diff --git a/previews/PR360/api/internal/index.html b/previews/PR360/api/internal/index.html new file mode 100644 index 000000000..0d327aa7b --- /dev/null +++ b/previews/PR360/api/internal/index.html @@ -0,0 +1,10 @@ + +Internal API Reference · PowerSimulationsDynamics.jl

Internal

PowerSimulationsDynamics.generator_inner_varsType

Generator Inner Vars:

  • τe_var :: Electric torque
  • τm_var :: Mechanical torque
  • Vf_var :: Field voltage
  • V_pss_var :: Additional PSS voltage
  • VR_gen_var :: Real part of the terminal voltage
  • VI_gen_var :: Imaginary part of the terminal voltage
  • ψd_var :: Stator Flux (if defined) in the d-axis
  • ψq_var :: Stator Flux (if defined) in the q-axis
source
PowerSimulationsDynamics.inverter_inner_varsType

Inverter Inner Vars:

  • md_var :: Modulation signal on the d-component
  • mq_var :: Modulation signal on the q-component
  • Vdc_var :: DC voltage supplied by the DC source
  • Vr_filter_var :: Voltage seen in the capacitor of the filter in the R-component
  • Vi_filter_var :: Voltage seen in the capacitor of the filter in the I-component
  • θ_freq_estimator_var :: Angle estimated by the frequency estimator.
  • ω_freq_estimator_var :: Frequency estimated by the frequency estimator.
  • V_oc_var :: Control voltage reference in the d-axis supplied from the outer loop control to the inner loop (for Voltage Mode Control)
  • Id_oc_var :: Control current reference in the d-axis supplied from the outer loop control to the inner loop (for Current Mode Control)
  • Iq_oc_var :: Control current reference in the q-axis supplied from the outer loop control to the inner loop (for Current Mode Control)
  • Id_ic_var :: Control current reference in the d-axis supplied from the inner loop control to the converter (for Generic Models)
  • Iq_ic_var :: Control current reference in the q-axis supplied from the inner loop control to the converter (for Generic Models)
  • Ir_cnv_var :: Control current reference in the R-axis supplied from the converter to the filter (for Generic Models)
  • Ii_cnv_var :: Control current reference in the I-axis supplied from the converter to the filter (for Generic Models)
  • ω_oc_var :: Control frequency supplied from the outer loop control the inner loop
  • θ_oc_var :: Variation of the angle (PLL or VSM) of the inverter
  • Vr_inv_var :: Real terminal voltage on the inverter
  • Vi_inv_var :: Imaginary terminal voltage on the inverter
  • Vr_cnv_var :: Voltage supplied from the converter in the R-component
  • Vi_cnv_var :: Voltage supplied from the converter in the I-component
  • P_ES_var :: Power supplied from the Energy Source side
source
PowerSimulationsDynamics._field_currentMethod

Function to obtain the field current time series of a Dynamic Generator. It is dispatched via the machine type. By default, machine does not have support for field current

source
PowerSimulationsDynamics._field_voltageMethod

Function to obtain the field voltage time series of a Dynamic Generator with avrs that have the field voltage as a state. By default it is assumed that the models have that state.

source
PowerSimulationsDynamics._frequencyMethod

Function to obtain the frequency time series of a virtual inertia grid forming inverter out of the DAE Solution. It is dispatched via the OuterControl type.

source
PowerSimulationsDynamics._frequencyMethod

Function to obtain the frequency time series of a grid-following inverter with KauraPLL out of the DAE Solution. It is dispatched via the OuterControl and FrequencyEstimator type.

source
PowerSimulationsDynamics._frequencyMethod

Function to obtain the frequency time series of a grid-following inverter with ReducedOrderPLL out of the DAE Solution. It is dispatched via the OuterControl and FrequencyEstimator type.

source
PowerSimulationsDynamics.compute_field_currentMethod

Function to obtain the field current time series of a Dynamic Generator model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. It is dispatched for device type to compute the specific current.

source
PowerSimulationsDynamics.compute_field_currentMethod

Function to obtain the field current time series of a Dynamic Inverter model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. It must return nothing since field current does not exists in inverters.

source
PowerSimulationsDynamics.compute_field_voltageMethod

Function to obtain the field voltage time series of a Dynamic Generator model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. It is dispatched for device type to compute the specific voltage.

source
PowerSimulationsDynamics.compute_field_voltageMethod

Function to obtain the field current time series of a Dynamic Inverter model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. It must return nothing since field voltage does not exists in inverters.

source
PowerSimulationsDynamics.compute_mechanical_torqueMethod

Function to obtain the mechanical torque time series of a Dynamic Generator model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. It is dispatched for device type to compute the specific torque.

source
PowerSimulationsDynamics.compute_mechanical_torqueMethod

Function to obtain the mechanical torque time series of a Dynamic Inverter model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. It must return nothing since mechanical torque is not used in inverters.

source
PowerSimulationsDynamics.compute_output_currentMethod

Function to obtain the output current time series of a PeriodicVariableSource model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. It is dispatched for device type to compute the specific current. computeoutputcurrent(::SimulationResults, ::PeriodicVariableSource, ::Vector{Float64}, ::Vector{Float64}, ::Nothing)

source
PowerSimulationsDynamics.compute_output_currentMethod

Function to obtain the output current time series of a Dynamic Generator model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. It is dispatched for device type to compute the specific current.

source
PowerSimulationsDynamics.compute_output_currentMethod

Function to obtain the output current time series of a Dynamic Inverter model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. It is dispatched for device type to compute the specific current.

source
PowerSimulationsDynamics.compute_pss_outputMethod

Function to obtain the pss output time series of a Dynamic Generator model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. It is dispatched for device type to compute the specific output.

source
PowerSimulationsDynamics.configure_loggingMethod
configure_logging(;
+    console_level = Logging.Error,
+    file_level = Logging.Info,
+    filename = "power-simulations.log",
+)

Creates console and file loggers.

Note: Log messages may not be written to the file until flush() or close() is called on the returned logger.

Arguments

  • console_level = Logging.Error: level for console messages
  • file_level = Logging.Info: level for file messages
  • filename::String = power-simulations.log: log file

Example

logger = configure_logging(console_level = Logging.Info)
+@info "log message"
+close(logger)
source
PowerSimulationsDynamics.device!Method

Model of 12-state Active Constant Power Load in Julia. Based on the paper Malicious Control of an Active Load in an Islanded Mixed-Source Microgrid by C. Roberts, U. Markovic, D. Arnold and D. Callaway.

source
PowerSimulationsDynamics.device!Method

Model of 3-state (SimplifiedSingleCageInductionMachine) induction motor in Julia. Based on the 3rd order model derived in Prabha Kundur's Book and the equations in "Analysis of Electric Machinery and Drive Systems" by Paul Krause, Oleg Wasynczuk and Scott Sudhoff.

source
PowerSimulationsDynamics.device!Method

Model of 5-state (SingleCageInductionMachine) induction motor in Julia. Refer to "Analysis of Electric Machinery and Drive Systems" by Paul Krause, Oleg Wasynczuk and Scott Sudhoff for the equations

source
PowerSimulationsDynamics.mdl_zip_load!Method

Model for ZIP Load model given by:

Pzip = Ppower + Pcurrent * (V / V0) + Pimpedance * (V / V0)^2 Qzip = Qpower + Qcurrent * (V / V0) + Qimpedance * (V / V0)^2

with V = sqrt(Vr^2 + Vi^2) and V0 the voltage magnitude from the power flow solution

The current taken for the load is computed as: Izip = (Pzip + j Qzip)^* / (Vr + j Vi)^* Izip = (Pzip - j Qzip) / (Vr - j Vi)

For constant impedance it is obtained: Izre = (1 / V0)^2 * (Vr * Pimpedance + Vi * Qimpedance) Izim = (1 / V0)^2 * (Vi * Pimpedance - Vr * Qimpedance)

For constant current it is obtained: Iire = (1 / V0) * ( (Vr * Pcurrent + Vi * Qcurrent) / V ) Iiim = (1 / V0) * ( (Vi * Pcurrent - Vr * Qcurrent) / V )

For constant power it is obtained: Ipre = (Vr * Ppower + Vi * Qpower) / V^2 Ipim = (Vi * Ppower - Vr * Qpower) / V^2

Model for Exponential Load model given by:

Pexp = P0 * (V / V0)^α Qexp = Q0 * (V / V0)^β

The current taken for the load is computed as: Iexp = (Pexp + j Qexp)^* / (Vr + j Vi)^* Iexp = (Pexp - j Qexp) / (Vr - j Vi)

It results: Irexp = Vr * P0 * (V^(α - 2) / V0^α) + Vi * Q0 * (V^(β - 2)/ V0^β) Iiim = Vi * P0 * (V^(α - 2) / V0^α) - Vr * Q0 * (V^(β - 2)/ V0^β)

source
diff --git a/previews/PR360/api/public/index.html b/previews/PR360/api/public/index.html new file mode 100644 index 000000000..e6cb4b4d8 --- /dev/null +++ b/previews/PR360/api/public/index.html @@ -0,0 +1,117 @@ + +Public API Reference · PowerSimulationsDynamics.jl

PowerSimulationsDynamics

PowerSimulationsDynamics.BranchImpedanceChangeType
mutable struct BranchImpedanceChange <: Perturbation
+    time::Float64
+    branch_type::Type{<:PSY.ACBranch}
+    branch_name::String
+    multiplier::Float64
+end

A BranchImpedanceChange change the impedance of a branch by a user defined multiplier. Currently there is only support for static branches disconnection, PowerSystems.Line and PowerSystems.Transformer2W. Future releases will provide support for a Dynamic Line disconnection.

Arguments:

  • time::Float64 : Defines when the Branch Impedance Change will happen. This time should be inside the time span considered in the Simulation
  • branch_tipe::Type{<:PowerSystems.ACBranch} : Type of branch modified
  • branch_name::String : User defined name for identifying the branch
  • multiplier::Float64 : User defined value for impedance multiplier.
source
PowerSimulationsDynamics.BranchTripType
mutable struct BranchTrip <: Perturbation
+    time::Float64
+    branch_type::Type{<:PowerSystems.ACBranch}
+    branch_name::String
+end

A BranchTrip completely disconnects a branch from the system. Currently there is only support for static branches disconnection, PowerSystems.Line and PowerSystems.Transformer2W. Future releases will provide support for a Dynamic Line disconnection. Note: Islanding is currently not supported in PowerSimulationsDynamics.jl. If a BranchTrip isolates a generation unit, the system may diverge due to the isolated generator.

Arguments:

  • time::Float64 : Defines when the Branch Trip will happen. This time should be inside the time span considered in the Simulation
  • branch_tipe::Type{<:PowerSystems.ACBranch} : Type of branch disconnected
  • branch_name::String : User defined name for identifying the branch
source
PowerSimulationsDynamics.ControlReferenceChangeType
mutable struct ControlReferenceChange <: Perturbation
+    time::Float64
+    device::PowerSystems.DynamicInjection
+    signal::Symbol
+    ref_value::Float64
+end

A ControlReferenceChange allows to change the reference setpoint provided by a generator/inverter.

Arguments:

  • time::Float64 : Defines when the Control Reference Change will happen. This time should be inside the time span considered in the Simulation
  • device::Type{<:PowerSystems.DynamicInjection} : Dynamic device modified
  • signal::Symbol : determines which reference setpoint will be modified. The accepted signals are:
    • :P_ref: Modifies the active power reference setpoint.
    • :V_ref: Modifies the voltage magnitude reference setpoint (if used).
    • :Q_ref: Modifies the reactive power reference setpoint (if used).
    • :ω_ref: Modifies the frequency setpoint.
  • ref_value::Float64 : User defined value for setpoint reference.
source
PowerSimulationsDynamics.GeneratorTripType
mutable struct GeneratorTrip <: Perturbation
+    time::Float64
+    device::PowerSystems.DynamicInjection
+end

A GeneratorTrip allows to disconnect a Dynamic Generation unit from the system at a specified time.

Arguments:

  • time::Float64 : Defines when the Generator Trip will happen. This time should be inside the time span considered in the Simulation
  • device::Type{<:PowerSystems.DynamicInjection} : Device to be disconnected
source
PowerSimulationsDynamics.LoadChangeType
mutable struct LoadChange <: Perturbation
+    time::Float64
+    device::PowerSystems.ElectricLoad
+    signal::Symbol
+    ref_value::Float64
+end

A LoadChange allows to change the active or reactive power setpoint from a load.

Arguments:

  • time::Float64 : Defines when the Load Change will happen. This time should be inside the time span considered in the Simulation
  • device::Type{<:PowerSystems.ElectricLoad} : Dynamic device modified
  • signal::Symbol : determines which reference setpoint will be modified. The accepted signals are:
    • :P_ref: Modifies the active power reference setpoint.
    • :Q_ref: Modifies the reactive power reference setpoint.
  • ref_value::Float64 : User defined value for setpoint reference.
source
PowerSimulationsDynamics.LoadTripType
mutable struct LoadTrip <: Perturbation
+    time::Float64
+    device::PowerSystems.ElectricLoad
+end

A LoadTrip allows the user to disconnect a load from the system.

Arguments:

  • time::Float64 : Defines when the Generator Trip will happen. This time should be inside the time span considered in the Simulation
  • device::Type{<:PowerSystems.ElectricLoad} : Device to be disconnected
source
PowerSimulationsDynamics.NetworkSwitchType
function NetworkSwitch(
+    time::Float64,
+    ybus::SparseArrays.SparseMatrixCSC{Complex{Float64}, Int},
+)

Allows to modify directly the admittance matrix, Ybus, used in the Simulation. This allows the user to perform branch modifications, three phase faults (with impedance larger than zero) or branch trips, as long as the new Ybus provided captures that perturbation.

Arguments:

  • time::Float64 : Defines when the Network Switch will happen. This time should be inside the time span considered in the Simulation
  • ybus::SparseArrays.SparseMatrixCSC{Complex{Float64}, Int} : Complex admittance matrix
source
PowerSimulationsDynamics.PerturbStateType
function PerturbState(
+    time::Float64,
+    index::Int,
+    value::Float64,
+)

Allows the user to modify the state index by adding value. The user should modify dynamic states only, since algebraic state may require to do a reinitialization.

Arguments:

  • time::Float64 : Defines when the modification of the state will happen. This time should be inside the time span considered in the Simulation.
  • index::Int : Defines which state index you want to modify
  • value::Float64 : Defines how much the state will increase in value
source
PowerSimulationsDynamics.SimulationMethod
function Simulation
+    ::SimulationModel
+    system::PowerSystems.System
+    simulation_folder::String
+    tspan::NTuple{2, Float64},
+    perturbations::Vector{<:Perturbation} = Vector{Perturbation}();
+    kwargs...,
+end

Builds the simulation object and conducts the indexing process. The original system is not modified and a copy its created and stored in the Simulation.

Arguments:

  • ::SimulationModel : Type of Simulation Model. ResidualModel or MassMatrixModel. See Models Section for more details
  • system::PowerSystems.System : System data
  • simulation_folder::String : Folder directory
  • tspan::NTuple{2, Float64} : Time span for simulation
  • perturbations::Vector{<:Perturbation} : Vector of Perturbations for the Simulation. Default: No Perturbations
  • initialize_simulation::Bool : Runs the initialization routine. If false, simulation runs based on the operation point stored in System
  • initial_conditions::Vector{Float64} : Allows the user to pass a vector with the initial condition values desired in the simulation. If initialize_simulation = true, these values are used as a first guess and overwritten.
  • frequency_reference : Default ReferenceBus. Determines which frequency model is used for the network. Currently there are two options available:
    • ConstantFrequency assumes that the network frequency is 1.0 per unit at all times.
    • ReferenceBus will use the frequency state of a Dynamic Generator (rotor speed) or Dynamic Inverter (virtual speed) connected to the Reference Bus (defined in the Power Flow data) as the network frequency. If multiple devices are connected to such bus, the device with larger base power will be used as a reference. If a Voltage Source is connected to the Reference Bus, then a ConstantFrequency model will be used.
  • system_to_file::Bool : Default false. Serializes the initialized system
  • console_level::Logging : Default Logging.Warn. Sets the level of logging output to the console. Can be set to Logging.Error, Logging.Warn, Logging.Info or Logging.Debug
  • file_level::Logging : Default Logging.Info. Sets the level of logging output to file. Can be set to Logging.Error, Logging.Warn, Logging.Info or Logging.Debug
  • disable_timer_outputs::Bool : Default false. Allows the user to display timer information about the construction and initilization of the Simulation.
source
PowerSimulationsDynamics.SourceBusVoltageChangeType
mutable struct SourceBusVoltageChange <: Perturbation
+    time::Float64
+    device::PSY.Source
+    signal::Symbol
+    ref_value::Float64
+end

A SourceBusVoltageChange allows to change the reference setpoint provided by a voltage source.

Arguments:

  • time::Float64 : Defines when the Control Reference Change will happen. This time should be inside the time span considered in the Simulation
  • device::Type{<:PowerSystems.Source} : Device modified
  • signal::Symbol : determines which reference setpoint will be modified. The accepted signals are:
    • :V_ref Modifies the internal voltage magnitude reference setpoint.
    • :θ_ref Modifies the internal voltage angle reference setpoint.
  • ref_value::Float64 : User defined value for setpoint reference.
source
PowerSimulationsDynamics.Simulation!Method
function Simulation!
+    ::SimulationModel
+    system::PowerSystems.System
+    simulation_folder::String
+    tspan::NTuple{2, Float64},
+    perturbations::Vector{<:Perturbation} = Vector{Perturbation}();
+    kwargs...,
+end

Builds the simulation object and conducts the indexing process. The initial conditions are stored in the system.

Arguments:

  • ::SimulationModel : Type of Simulation Model. ResidualModel or MassMatrixModel. See Models Section for more details
  • system::PowerSystems.System : System data
  • simulation_folder::String : Folder directory
  • tspan::NTuple{2, Float64} : Time span for simulation
  • perturbations::Vector{<:Perturbation} : Vector of Perturbations for the Simulation. Default: No Perturbations
  • initialize_simulation::Bool : Runs the initialization routine. If false, simulation runs based on the operation point stored in System
  • initial_conditions::Vector{Float64} : Allows the user to pass a vector with the initial condition values desired in the simulation. If initialize_simulation = true, these values are used as a first guess and overwritten.
  • frequency_reference : Default ReferenceBus. Determines which frequency model is used for the network. Currently there are two options available:
    • ConstantFrequency assumes that the network frequency is 1.0 per unit at all times.
    • ReferenceBus will use the frequency state of a Dynamic Generator (rotor speed) or Dynamic Inverter (virtual speed) connected to the Reference Bus (defined in the Power Flow data) as the network frequency. If multiple devices are connected to such bus, the device with larger base power will be used as a reference. If a Voltage Source is connected to the Reference Bus, then a ConstantFrequency model will be used.
  • system_to_file::Bool : Default false. Serializes the initialized system
  • console_level::Logging : Default Logging.Warn. Sets the level of logging output to the console. Can be set to Logging.Error, Logging.Warn, Logging.Info or Logging.Debug
  • file_level::Logging : Default Logging.Info. Sets the level of logging output to file. Can be set to Logging.Error, Logging.Warn, Logging.Info or Logging.Debug
  • disable_timer_outputs::Bool : Default false. Allows the user to display timer information about the construction and initilization of the Simulation.
source
PowerSimulationsDynamics.execute!Method
execute!(
+    sim::Simulation,
+    solver;
+    kwargs...
+)

Solves the time-domain dynamic simulation model.

Arguments

  • sim::Simulation : Initialized simulation object
  • solver : Solver used for numerical integration. Must be passed correctly depending on the Type of Simulation Model
  • enable_progress_bar::Bool : Default: true. Enables progress bar for the integration routine.
  • Additional solver keyword arguments can be included. See Common Solver Options in the DifferentialEquations.jl documentation for more details.
source
PowerSimulationsDynamics.get_activepower_branch_flowMethod
get_activepower_branch_flow(
+        res::SimulationResults,
+        name::String,
+        location::Symbol,
+)

Function to obtain the active power flowing through the series element of a Branch. The user must specified is the power should be computed in the :from or to :bus, by specifying a symbol.

If :from is specified, the power is computed flowing outwards the :from bus. If :to is specified, the power is computed flowing into the :to bus.

Arguments

  • res::SimulationResults : Simulation Results object that contains the solution
  • name::String : Name to identify the specified line
  • location::Symbol : :from or :to to specify a bus
source
PowerSimulationsDynamics.get_activepower_seriesMethod
get_activepower_series(
+        res::SimulationResults,
+        name::String,
+)

Function to obtain the active power output time series of a Dynamic Injection series out of the DAE Solution.

Arguments

  • res::SimulationResults : Simulation Results object that contains the solution
  • name::String : Name to identify the specified device
source
PowerSimulationsDynamics.get_field_current_seriesMethod
get_field_current_series(
+        res::SimulationResults,
+        name::String,
+)

Function to obtain the field current time series of a Dynamic Generator out of the DAE Solution.

Arguments

  • res::SimulationResults : Simulation Results object that contains the solution
  • name::String : Name to identify the specified device
source
PowerSimulationsDynamics.get_field_voltage_seriesMethod
get_field_voltage_series(
+        res::SimulationResults,
+        name::String,
+)

Function to obtain the field voltage time series of a Dynamic Generator out of the DAE Solution.

Arguments

  • res::SimulationResults : Simulation Results object that contains the solution
  • name::String : Name to identify the specified device
source
PowerSimulationsDynamics.get_frequency_seriesMethod
get_frequency_series(
+        res::SimulationResults,
+        name::String,
+)

Function to obtain the frequency time series of a Dynamic Injection out of the DAE Solution.

Arguments

  • res::SimulationResults : Simulation Results object that contains the solution
  • name::String : Name to identify the specified device
source
PowerSimulationsDynamics.get_imaginary_current_branch_flowMethod
get_imaginary_current_branch_flow(
+        res::SimulationResults,
+        name::String,
+)

Function to obtain the imaginary current flowing through the series element of a Branch

Arguments

  • res::SimulationResults : Simulation Results object that contains the solution
  • name::String : Name to identify the specified line
source
PowerSimulationsDynamics.get_imaginary_current_seriesMethod
get_imaginary_current_series(
+        res::SimulationResults,
+        name::String,
+)

Function to obtain the imaginary current time series of a Dynamic Injection series out of the DAE Solution.

Arguments

  • res::SimulationResults : Simulation Results object that contains the solution
  • name::String : Name to identify the specified device
source
PowerSimulationsDynamics.get_jacobianMethod
function get_jacobian(
+::Type{T},
+system::PSY.System,
+sparse_retrieve_loop::Int = 3,
+) where {T <: SimulationModel}

Returns the jacobian function of the system model resulting from the system data.

Arguments:

  • ::SimulationModel : Type of Simulation Model. ResidualModel or MassMatrixModel. See Models Section for more details
  • system::PowerSystems.System : System data
  • sparse_retrieve_loop::Int : Number of loops for sparsity detection. If 0, builds the Jacobian with a DenseMatrix
source
PowerSimulationsDynamics.get_mechanical_torque_seriesMethod
get_mechanical_torque_series(
+        res::SimulationResults,
+        name::String,
+)

Function to obtain the mechanical torque time series of the mechanical torque out of the DAE Solution.

Arguments

  • res::SimulationResults : Simulation Results object that contains the solution
  • name::String : Name to identify the specified device
source
PowerSimulationsDynamics.get_pss_output_seriesMethod
get_pss_output_series(
+        res::SimulationResults,
+        name::String,
+)

Function to obtain the pss output time series of a Dynamic Generator out of the DAE Solution.

Arguments

  • res::SimulationResults : Simulation Results object that contains the solution
  • name::String : Name to identify the specified device
source
PowerSimulationsDynamics.get_reactivepower_branch_flowMethod
get_reactivepower_branch_flow(
+        res::SimulationResults,
+        name::String,
+        location::Symbol,
+)

Function to obtain the reactive power flowing through the series element of a Branch. The user must specified is the power should be computed in the :from or to :bus, by specifying a symbol.

If :from is specified, the power is computed flowing outwards the :from bus. If :to is specified, the power is computed flowing into the :to bus.

Arguments

  • res::SimulationResults : Simulation Results object that contains the solution
  • name::String : Name to identify the specified line
  • location::Symbol : :from or :to to specify a bus
source
PowerSimulationsDynamics.get_reactivepower_seriesMethod
get_reactivepower_series(
+        res::SimulationResults,
+        name::String,
+)

Function to obtain the reactive power output time series of a Dynamic Injection series out of the DAE Solution.

Arguments

  • res::SimulationResults : Simulation Results object that contains the solution
  • name::String : Name to identify the specified device
source
PowerSimulationsDynamics.get_real_current_branch_flowMethod
get_real_current_branch_flow(
+        res::SimulationResults,
+        name::String,
+)

Function to obtain the real current flowing through the series element of a Branch

Arguments

  • res::SimulationResults : Simulation Results object that contains the solution
  • name::String : Name to identify the specified line
source
PowerSimulationsDynamics.get_real_current_seriesMethod
get_real_current_series(
+        res::SimulationResults,
+        name::String,
+)

Function to obtain the real current time series of a Dynamic Injection series out of the DAE Solution.

Arguments

  • res::SimulationResults : Simulation Results object that contains the solution
  • name::String : Name to identify the specified device
source
PowerSimulationsDynamics.get_setpointsMethod
get_setpoints(sim::Simulation)

Function that returns the reference setpoints for all the dynamic devices.

Arguments

  • sim::Simulation : Simulation object that contains the initial condition and setpoints.
source
PowerSimulationsDynamics.get_state_seriesMethod
get_state_series(
+    res::SimulationResults,
+    ref::Tuple{String, Symbol};
+    dt::Union{Nothing, Float64} = nothing
+)
+end

Function to obtain series of states out of DAE Solution.

Arguments

  • res::SimulationResults : Simulation Results object that contains the solution
  • ref:Tuple{String, Symbol} : Tuple used to identify the dynamic device, via its name, as a String, and the associated state as a Symbol.
source
PowerSimulationsDynamics.get_voltage_angle_seriesMethod
get_voltage_angle_series(
+    res::SimulationResults,
+    bus_number::Int
+)

Function to obtain the voltage angle series out of the DAE Solution.

Arguments

  • res::SimulationResults : Simulation Results object that contains the solution
  • bus_number::Int : Bus number identifier
source
PowerSimulationsDynamics.get_voltage_magnitude_seriesMethod
get_voltage_magnitude_series(
+    res::SimulationResults,
+    bus_number::Int
+)

Function to obtain the voltage magnitude series out of the DAE Solution.

Arguments:

  • res::SimulationResults : Simulation Results object that contains the solution
  • bus_number::Int : Bus number identifier
source
PowerSimulationsDynamics.summary_eigenvaluesMethod
summary_eigenvalues(
+        sm::SmallSignalOutput,
+)

Function to obtain a summary of the eigenvalues of the Jacobian at the operating point. It returns a DataFrame with the most associated state for each eigenvalue, its real and imaginary part, damping and frequency.

Arguments

  • sm::SmallSignalOutput : Small Signal Output object that contains the eigenvalues and participation factors
source
PowerSimulationsDynamics.summary_participation_factorsMethod
summary_participation_factors(
+        sm::SmallSignalOutput,
+)

Function to obtain the participation factor of each state to each eigenvalue. It returns a DataFrame with the participation factors of each state to all eigenvalues.

Arguments

  • sm::SmallSignalOutput : Small Signal Output object that contains the eigenvalues and participation factors
source
diff --git a/previews/PR360/assets/SoftwareLoop.jpg b/previews/PR360/assets/SoftwareLoop.jpg new file mode 100644 index 000000000..5de80cb62 Binary files /dev/null and b/previews/PR360/assets/SoftwareLoop.jpg differ diff --git a/previews/PR360/assets/active_ren.png b/previews/PR360/assets/active_ren.png new file mode 100644 index 000000000..46446a194 Binary files /dev/null and b/previews/PR360/assets/active_ren.png differ diff --git a/previews/PR360/assets/documenter.js b/previews/PR360/assets/documenter.js new file mode 100644 index 000000000..32e27c514 --- /dev/null +++ b/previews/PR360/assets/documenter.js @@ -0,0 +1,340 @@ +// Generated by Documenter.jl +requirejs.config({ + paths: { + 'highlight-julia': 'https://cdnjs.cloudflare.com/ajax/libs/highlight.js/11.5.1/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.12.1/jquery-ui.min', + 'jquery': 'https://cdnjs.cloudflare.com/ajax/libs/jquery/3.6.0/jquery.min', + 'mathjax': 'https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.7/MathJax.js?config=TeX-AMS_HTML', + 'headroom-jquery': 'https://cdnjs.cloudflare.com/ajax/libs/headroom/0.12.0/jQuery.headroom.min', + 'highlight': 'https://cdnjs.cloudflare.com/ajax/libs/highlight.js/11.5.1/highlight.min', + 'highlight-julia-repl': 'https://cdnjs.cloudflare.com/ajax/libs/highlight.js/11.5.1/languages/julia-repl.min', + }, + shim: { + "highlight-julia": { + "deps": [ + "highlight" + ] + }, + "mathjax": { + "exports": "MathJax" + }, + "headroom-jquery": { + "deps": [ + "jquery", + "headroom" + ] + }, + "highlight-julia-repl": { + "deps": [ + "highlight" + ] + } +} +}); +//////////////////////////////////////////////////////////////////////////////// +require(['mathjax'], function(MathJax) { +MathJax.Hub.Config({ + "jax": [ + "input/TeX", + "output/HTML-CSS", + "output/NativeMML" + ], + "TeX": { + "equationNumbers": { + "autoNumber": "AMS" + } + }, + "tex2jax": { + "inlineMath": [ + [ + "$", + "$" + ], + [ + "\\(", + "\\)" + ] + ], + "processEscapes": true + }, + "config": [ + "MMLorHTML.js" + ], + "extensions": [ + "MathMenu.js", + "MathZoom.js", + "TeX/AMSmath.js", + "TeX/AMSsymbols.js", + "TeX/autobold.js", + "TeX/autoload-all.js" + ] +} +); + +}) +//////////////////////////////////////////////////////////////////////////////// +require(['jquery', 'highlight', 'highlight-julia', 'highlight-julia-repl'], function($) { +$(document).ready(function() { + hljs.highlightAll(); +}) + +}) +//////////////////////////////////////////////////////////////////////////////// +require([], function() { +function addCopyButtonCallbacks() { + for (const el of document.getElementsByTagName("pre")) { + const button = document.createElement("button"); + button.classList.add("copy-button", "fas", "fa-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-times"); + 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-times"); + }, 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($) { + +// 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($) { + +// 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($) { + +function set_theme(theme) { + var active = null; + var disabled = []; + for (var i = 0; i < document.styleSheets.length; i++) { + var ss = document.styleSheets[i]; + var themename = ss.ownerNode.getAttribute("data-theme-name"); + if(themename === null) continue; // ignore non-theme stylesheets + // Find the active theme + if(themename === theme) active = ss; + else disabled.push(ss); + } + if(active !== null) { + active.disabled = false; + if(active.ownerNode.getAttribute("data-theme-primary") === null) { + document.getElementsByTagName('html')[0].className = "theme--" + theme; + } else { + document.getElementsByTagName('html')[0].className = ""; + } + disabled.forEach(function(ss){ + ss.disabled = true; + }); + } + + // Store the theme in localStorage + if(typeof(window.localStorage) !== "undefined") { + window.localStorage.setItem("documenter-theme", theme); + } else { + console.error("Browser does not support window.localStorage"); + } +} + +// Theme picker setup +$(document).ready(function() { + // onchange callback + $('#documenter-themepicker').change(function themepick_callback(ev){ + var themename = $('#documenter-themepicker option:selected').attr('value'); + set_theme(themename); + }); + + // 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); + }) + } else { + $('#documenter-themepicker option').each(function(i,e) { + e.selected = $("html").hasClass(`theme--${e.value}`); + }) + } + } +}) + +}) +//////////////////////////////////////////////////////////////////////////////// +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/PR360/assets/f-plot.svg b/previews/PR360/assets/f-plot.svg new file mode 100644 index 000000000..232bdeb04 --- /dev/null +++ b/previews/PR360/assets/f-plot.svg @@ -0,0 +1,153 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR360/assets/generic_vsc.png b/previews/PR360/assets/generic_vsc.png new file mode 100644 index 000000000..4d7b4dfc4 Binary files /dev/null and b/previews/PR360/assets/generic_vsc.png differ diff --git a/previews/PR360/assets/inner_reecb.png b/previews/PR360/assets/inner_reecb.png new file mode 100644 index 000000000..098d2b960 Binary files /dev/null and b/previews/PR360/assets/inner_reecb.png differ diff --git a/previews/PR360/assets/inverter_init.png b/previews/PR360/assets/inverter_init.png new file mode 100644 index 000000000..5b104581f Binary files /dev/null and b/previews/PR360/assets/inverter_init.png differ diff --git a/previews/PR360/assets/logo.png b/previews/PR360/assets/logo.png new file mode 100644 index 000000000..c0c5d7d59 Binary files /dev/null and b/previews/PR360/assets/logo.png differ diff --git a/previews/PR360/assets/reactive_ren.png b/previews/PR360/assets/reactive_ren.png new file mode 100644 index 000000000..2efc003b0 Binary files /dev/null and b/previews/PR360/assets/reactive_ren.png differ diff --git a/previews/PR360/assets/search.js b/previews/PR360/assets/search.js new file mode 100644 index 000000000..c133f7410 --- /dev/null +++ b/previews/PR360/assets/search.js @@ -0,0 +1,267 @@ +// Generated by Documenter.jl +requirejs.config({ + paths: { + 'lunr': 'https://cdnjs.cloudflare.com/ajax/libs/lunr.js/2.3.9/lunr.min', + 'lodash': 'https://cdnjs.cloudflare.com/ajax/libs/lodash.js/4.17.21/lodash.min', + 'jquery': 'https://cdnjs.cloudflare.com/ajax/libs/jquery/3.6.0/jquery.min', + } +}); +//////////////////////////////////////////////////////////////////////////////// +require(['jquery', 'lunr', 'lodash'], function($, lunr, _) { + +$(document).ready(function() { + // parseUri 1.2.2 + // (c) Steven Levithan + // MIT License + function parseUri (str) { + var o = parseUri.options, + m = o.parser[o.strictMode ? "strict" : "loose"].exec(str), + uri = {}, + i = 14; + + while (i--) uri[o.key[i]] = m[i] || ""; + + uri[o.q.name] = {}; + uri[o.key[12]].replace(o.q.parser, function ($0, $1, $2) { + if ($1) uri[o.q.name][$1] = $2; + }); + + return uri; + }; + parseUri.options = { + strictMode: false, + key: ["source","protocol","authority","userInfo","user","password","host","port","relative","path","directory","file","query","anchor"], + q: { + name: "queryKey", + parser: /(?:^|&)([^&=]*)=?([^&]*)/g + }, + parser: { + strict: /^(?:([^:\/?#]+):)?(?:\/\/((?:(([^:@]*)(?::([^:@]*))?)?@)?([^:\/?#]*)(?::(\d*))?))?((((?:[^?#\/]*\/)*)([^?#]*))(?:\?([^#]*))?(?:#(.*))?)/, + loose: /^(?:(?![^:@]+:[^:@\/]*@)([^:\/?#.]+):)?(?:\/\/)?((?:(([^:@]*)(?::([^:@]*))?)?@)?([^:\/?#]*)(?::(\d*))?)(((\/(?:[^?#](?![^?#\/]*\.[^?#\/.]+(?:[?#]|$)))*\/?)?([^?#\/]*))(?:\?([^#]*))?(?:#(.*))?)/ + } + }; + + $("#search-form").submit(function(e) { + e.preventDefault() + }) + + // 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 + lunr.stopWordFilter = lunr.generateStopWordFilter([ + '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' + ]) + + // add . as a separator, because otherwise "title": "Documenter.Anchors.add!" + // would not find anything if searching for "add!", only for the entire qualification + lunr.tokenizer.separator = /[\s\-\.]+/ + + // custom trimmer that doesn't strip @ and !, which are used in julia macro and function names + lunr.trimmer = function (token) { + return token.update(function (s) { + return s.replace(/^[^a-zA-Z0-9@!]+/, '').replace(/[^a-zA-Z0-9@!]+$/, '') + }) + } + + lunr.Pipeline.registerFunction(lunr.stopWordFilter, 'juliaStopWordFilter') + lunr.Pipeline.registerFunction(lunr.trimmer, 'juliaTrimmer') + + var index = lunr(function () { + this.ref('location') + this.field('title',{boost: 100}) + this.field('text') + documenterSearchIndex['docs'].forEach(function(e) { + this.add(e) + }, this) + }) + var store = {} + + documenterSearchIndex['docs'].forEach(function(e) { + store[e.location] = {title: e.title, category: e.category, page: e.page} + }) + + $(function(){ + searchresults = $('#documenter-search-results'); + searchinfo = $('#documenter-search-info'); + searchbox = $('#documenter-search-query'); + searchform = $('.docs-search'); + sidebar = $('.docs-sidebar'); + function update_search(querystring) { + tokens = lunr.tokenizer(querystring) + results = index.query(function (q) { + tokens.forEach(function (t) { + q.term(t.toString(), { + fields: ["title"], + boost: 100, + usePipeline: true, + editDistance: 0, + wildcard: lunr.Query.wildcard.NONE + }) + q.term(t.toString(), { + fields: ["title"], + boost: 10, + usePipeline: true, + editDistance: 2, + wildcard: lunr.Query.wildcard.NONE + }) + q.term(t.toString(), { + fields: ["text"], + boost: 1, + usePipeline: true, + editDistance: 0, + wildcard: lunr.Query.wildcard.NONE + }) + }) + }) + searchinfo.text("Number of results: " + results.length) + searchresults.empty() + results.forEach(function(result) { + data = store[result.ref] + link = $(''+data.title+'') + link.attr('href', documenterBaseURL+'/'+result.ref) + if (data.category != "page"){ + cat = $('('+data.category+', '+data.page+')') + } else { + cat = $('('+data.category+')') + } + li = $('
  • ').append(link).append(" ").append(cat) + searchresults.append(li) + }) + } + + function update_search_box() { + querystring = searchbox.val() + update_search(querystring) + } + + searchbox.keyup(_.debounce(update_search_box, 250)) + searchbox.change(update_search_box) + + // Disable enter-key form submission for the searchbox on the search page + // and just re-run search rather than refresh the whole page. + searchform.keypress( + function(event){ + if (event.which == '13') { + if (sidebar.hasClass('visible')) { + sidebar.removeClass('visible'); + } + update_search_box(); + event.preventDefault(); + } + } + ); + + search_query_uri = parseUri(window.location).queryKey["q"] + if(search_query_uri !== undefined) { + search_query = decodeURIComponent(search_query_uri.replace(/\+/g, '%20')) + searchbox.val(search_query) + } + update_search_box(); + }) +}) + +}) diff --git a/previews/PR360/assets/synch_init.png b/previews/PR360/assets/synch_init.png new file mode 100644 index 000000000..8dbf69a0a Binary files /dev/null and b/previews/PR360/assets/synch_init.png differ diff --git a/previews/PR360/assets/sys_init.png b/previews/PR360/assets/sys_init.png new file mode 100644 index 000000000..2619bb949 Binary files /dev/null and b/previews/PR360/assets/sys_init.png differ diff --git a/previews/PR360/assets/themes/documenter-dark.css b/previews/PR360/assets/themes/documenter-dark.css new file mode 100644 index 000000000..c94a294dc --- /dev/null +++ b/previews/PR360/assets/themes/documenter-dark.css @@ -0,0 +1,7 @@ +@keyframes spinAround{from{transform:rotate(0deg)}to{transform:rotate(359deg)}}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,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}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 .message:not(:last-child),html.theme--documenter-dark .list:not(:last-child),html.theme--documenter-dark .level:not(:last-child),html.theme--documenter-dark .breadcrumb:not(:last-child),html.theme--documenter-dark .highlight: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{-moz-appearance:none;-webkit-appearance:none;background-color:rgba(10,10,10,0.2);border:none;border-radius:290486px;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:290486px;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 .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:15px;height:2.25em;justify-content:flex-start;line-height:1.5;padding-bottom:calc(0.375em - 1px);padding-left:calc(0.625em - 1px);padding-right:calc(0.625em - 1px);padding-top:calc(0.375em - 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}/*! minireset.css v0.0.4 | 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,embed,iframe,object,video{height:auto;max-width:100%}audio{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:left}.is-clearfix::after{clear:both;content:" ";display:table}.is-pulled-left{float:left !important}.is-pulled-right{float:right !important}.is-clipped{overflow:hidden !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:15px !important}.is-size-7,html.theme--documenter-dark .docstring>section>a.docs-sourcelink{font-size:.85em !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:15px !important}.is-size-7-mobile{font-size:.85em !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:15px !important}.is-size-7-tablet{font-size:.85em !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:15px !important}.is-size-7-touch{font-size:.85em !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:15px !important}.is-size-7-desktop{font-size:.85em !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:15px !important}.is-size-7-widescreen{font-size:.85em !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:15px !important}.is-size-7-fullhd{font-size:.85em !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}.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-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-info{color:#024c7d !important}a.has-text-info:hover,a.has-text-info:focus{color:#012d4b !important}.has-background-info{background-color:#024c7d !important}.has-text-success{color:#008438 !important}a.has-text-success:hover,a.has-text-success:focus{color:#005122 !important}.has-background-success{background-color:#008438 !important}.has-text-warning{color:#ad8100 !important}a.has-text-warning:hover,a.has-text-warning:focus{color:#7a5b00 !important}.has-background-warning{background-color:#ad8100 !important}.has-text-danger{color:#9e1b0d !important}a.has-text-danger:hover,a.has-text-danger:focus{color:#6f1309 !important}.has-background-danger{background-color:#9e1b0d !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}.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}}.is-marginless{margin:0 !important}.is-paddingless{padding:0 !important}.is-radiusless{border-radius:0 !important}.is-shadowless{box-shadow:none !important}.is-relative{position:relative !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 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:left}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 2px 3px 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.375em - 1px);padding-left:.75em;padding-right:.75em;padding-top:calc(0.375em - 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.375em - 1px);margin-right:0.1875em}html.theme--documenter-dark .button .icon:last-child:not(:first-child){margin-left:0.1875em;margin-right:calc(-0.375em - 1px)}html.theme--documenter-dark .button .icon:first-child:last-child{margin-left:calc(-0.375em - 1px);margin-right:calc(-0.375em - 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-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:transparent;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:transparent;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:#282f2f}html.theme--documenter-dark .button.is-light:hover,html.theme--documenter-dark .button.is-light.is-hovered{background-color:#e5eaec;border-color:transparent;color:#282f2f}html.theme--documenter-dark .button.is-light:focus,html.theme--documenter-dark .button.is-light.is-focused{border-color:transparent;color:#282f2f}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:#282f2f}html.theme--documenter-dark .button.is-light[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-light{background-color:#ecf0f1;border-color:transparent;box-shadow:none}html.theme--documenter-dark .button.is-light.is-inverted{background-color:#282f2f;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:#1d2122}html.theme--documenter-dark .button.is-light.is-inverted[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-light.is-inverted{background-color:#282f2f;border-color:transparent;box-shadow:none;color:#ecf0f1}html.theme--documenter-dark .button.is-light.is-loading::after{border-color:transparent transparent #282f2f #282f2f !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:#282f2f}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 #282f2f #282f2f !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:#282f2f;color:#282f2f}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:#282f2f;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:#282f2f;box-shadow:none;color:#282f2f}html.theme--documenter-dark .button.is-dark,html.theme--documenter-dark .content kbd.button{background-color:#282f2f;border-color:transparent;color:#ecf0f1}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:#ecf0f1}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:#ecf0f1}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:#ecf0f1}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:transparent;box-shadow:none}html.theme--documenter-dark .button.is-dark.is-inverted,html.theme--documenter-dark .content kbd.button.is-inverted{background-color:#ecf0f1;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:#dde4e6}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:#ecf0f1;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 #ecf0f1 #ecf0f1 !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:#ecf0f1}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 #ecf0f1 #ecf0f1 !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:#ecf0f1;color:#ecf0f1}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:#ecf0f1;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:#ecf0f1;box-shadow:none;color:#ecf0f1}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:transparent;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-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:transparent;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-info{background-color:#024c7d;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-info:hover,html.theme--documenter-dark .button.is-info.is-hovered{background-color:#024470;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(2,76,125,0.25)}html.theme--documenter-dark .button.is-info:active,html.theme--documenter-dark .button.is-info.is-active{background-color:#023d64;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-info[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-info{background-color:#024c7d;border-color:transparent;box-shadow:none}html.theme--documenter-dark .button.is-info.is-inverted{background-color:#fff;color:#024c7d}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:#024c7d}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:#024c7d;color:#024c7d}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:#024c7d;border-color:#024c7d;color:#fff}html.theme--documenter-dark .button.is-info.is-outlined.is-loading::after{border-color:transparent transparent #024c7d #024c7d !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:#024c7d;box-shadow:none;color:#024c7d}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:#024c7d}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 #024c7d #024c7d !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-success{background-color:#008438;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-success:hover,html.theme--documenter-dark .button.is-success.is-hovered{background-color:#073;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(0,132,56,0.25)}html.theme--documenter-dark .button.is-success:active,html.theme--documenter-dark .button.is-success.is-active{background-color:#006b2d;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-success[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-success{background-color:#008438;border-color:transparent;box-shadow:none}html.theme--documenter-dark .button.is-success.is-inverted{background-color:#fff;color:#008438}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:#008438}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:#008438;color:#008438}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:#008438;border-color:#008438;color:#fff}html.theme--documenter-dark .button.is-success.is-outlined.is-loading::after{border-color:transparent transparent #008438 #008438 !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:#008438;box-shadow:none;color:#008438}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:#008438}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 #008438 #008438 !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-warning{background-color:#ad8100;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-warning:hover,html.theme--documenter-dark .button.is-warning.is-hovered{background-color:#a07700;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-warning:focus,html.theme--documenter-dark .button.is-warning.is-focused{border-color:transparent;color:#fff}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(173,129,0,0.25)}html.theme--documenter-dark .button.is-warning:active,html.theme--documenter-dark .button.is-warning.is-active{background-color:#946e00;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-warning[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-warning{background-color:#ad8100;border-color:transparent;box-shadow:none}html.theme--documenter-dark .button.is-warning.is-inverted{background-color:#fff;color:#ad8100}html.theme--documenter-dark .button.is-warning.is-inverted:hover,html.theme--documenter-dark .button.is-warning.is-inverted.is-hovered{background-color:#f2f2f2}html.theme--documenter-dark .button.is-warning.is-inverted[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-warning.is-inverted{background-color:#fff;border-color:transparent;box-shadow:none;color:#ad8100}html.theme--documenter-dark .button.is-warning.is-loading::after{border-color:transparent transparent #fff #fff !important}html.theme--documenter-dark .button.is-warning.is-outlined{background-color:transparent;border-color:#ad8100;color:#ad8100}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:#ad8100;border-color:#ad8100;color:#fff}html.theme--documenter-dark .button.is-warning.is-outlined.is-loading::after{border-color:transparent transparent #ad8100 #ad8100 !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 #fff #fff !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:#ad8100;box-shadow:none;color:#ad8100}html.theme--documenter-dark .button.is-warning.is-inverted.is-outlined{background-color:transparent;border-color:#fff;color:#fff}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:#fff;color:#ad8100}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 #ad8100 #ad8100 !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:#fff;box-shadow:none;color:#fff}html.theme--documenter-dark .button.is-danger{background-color:#9e1b0d;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-danger:hover,html.theme--documenter-dark .button.is-danger.is-hovered{background-color:#92190c;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(158,27,13,0.25)}html.theme--documenter-dark .button.is-danger:active,html.theme--documenter-dark .button.is-danger.is-active{background-color:#86170b;border-color:transparent;color:#fff}html.theme--documenter-dark .button.is-danger[disabled],fieldset[disabled] html.theme--documenter-dark .button.is-danger{background-color:#9e1b0d;border-color:transparent;box-shadow:none}html.theme--documenter-dark .button.is-danger.is-inverted{background-color:#fff;color:#9e1b0d}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:#9e1b0d}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:#9e1b0d;color:#9e1b0d}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:#9e1b0d;border-color:#9e1b0d;color:#fff}html.theme--documenter-dark .button.is-danger.is-outlined.is-loading::after{border-color:transparent transparent #9e1b0d #9e1b0d !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:#9e1b0d;box-shadow:none;color:#9e1b0d}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:#9e1b0d}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 #9e1b0d #9e1b0d !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-small,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.button{border-radius:3px;font-size:.85em}html.theme--documenter-dark .button.is-normal{font-size:15px}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:#dbdee0;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 / 2));top:calc(50% - (1em / 2));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:290486px;padding-left:1em;padding-right:1em}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:0.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){border-radius:3px;font-size:.85em}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}html.theme--documenter-dark .container{flex-grow:1;margin:0 auto;position:relative;width:auto}@media screen and (min-width: 1056px){html.theme--documenter-dark .container{max-width:992px}html.theme--documenter-dark .container.is-fluid{margin-left:32px;margin-right:32px;max-width:none}}@media screen and (max-width: 1215px){html.theme--documenter-dark .container.is-widescreen{max-width:1152px}}@media screen and (max-width: 1407px){html.theme--documenter-dark .container.is-fullhd{max-width:1344px}}@media screen and (min-width: 1216px){html.theme--documenter-dark .container{max-width:1152px}}@media screen and (min-width: 1408px){html.theme--documenter-dark .container{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:left}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:.85em}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 .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:290486px}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;padding:1.25rem 2.5rem 1.25rem 1.5rem;position:relative}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{position:absolute;right:0.5rem;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:#282f2f}html.theme--documenter-dark .notification.is-dark,html.theme--documenter-dark .content kbd.notification{background-color:#282f2f;color:#ecf0f1}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-link{background-color:#1abc9c;color:#fff}html.theme--documenter-dark .notification.is-info{background-color:#024c7d;color:#fff}html.theme--documenter-dark .notification.is-success{background-color:#008438;color:#fff}html.theme--documenter-dark .notification.is-warning{background-color:#ad8100;color:#fff}html.theme--documenter-dark .notification.is-danger{background-color:#9e1b0d;color:#fff}html.theme--documenter-dark .progress{-moz-appearance:none;-webkit-appearance:none;border:none;border-radius:290486px;display:block;height:15px;overflow:hidden;padding:0;width:100%}html.theme--documenter-dark .progress::-webkit-progress-bar{background-color:#5e6d6f}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%, #5e6d6f 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%, #5e6d6f 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%, #5e6d6f 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%, #5e6d6f 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%, #5e6d6f 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%, #5e6d6f 30%)}html.theme--documenter-dark .progress.is-info::-webkit-progress-value{background-color:#024c7d}html.theme--documenter-dark .progress.is-info::-moz-progress-bar{background-color:#024c7d}html.theme--documenter-dark .progress.is-info::-ms-fill{background-color:#024c7d}html.theme--documenter-dark .progress.is-info:indeterminate{background-image:linear-gradient(to right, #024c7d 30%, #5e6d6f 30%)}html.theme--documenter-dark .progress.is-success::-webkit-progress-value{background-color:#008438}html.theme--documenter-dark .progress.is-success::-moz-progress-bar{background-color:#008438}html.theme--documenter-dark .progress.is-success::-ms-fill{background-color:#008438}html.theme--documenter-dark .progress.is-success:indeterminate{background-image:linear-gradient(to right, #008438 30%, #5e6d6f 30%)}html.theme--documenter-dark .progress.is-warning::-webkit-progress-value{background-color:#ad8100}html.theme--documenter-dark .progress.is-warning::-moz-progress-bar{background-color:#ad8100}html.theme--documenter-dark .progress.is-warning::-ms-fill{background-color:#ad8100}html.theme--documenter-dark .progress.is-warning:indeterminate{background-image:linear-gradient(to right, #ad8100 30%, #5e6d6f 30%)}html.theme--documenter-dark .progress.is-danger::-webkit-progress-value{background-color:#9e1b0d}html.theme--documenter-dark .progress.is-danger::-moz-progress-bar{background-color:#9e1b0d}html.theme--documenter-dark .progress.is-danger::-ms-fill{background-color:#9e1b0d}html.theme--documenter-dark .progress.is-danger:indeterminate{background-image:linear-gradient(to right, #9e1b0d 30%, #5e6d6f 30%)}html.theme--documenter-dark .progress:indeterminate{animation-duration:1.5s;animation-iteration-count:infinite;animation-name:moveIndeterminate;animation-timing-function:linear;background-color:#5e6d6f;background-image:linear-gradient(to right, #fff 30%, #5e6d6f 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.is-small,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.progress{height:.85em}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:#282f2f}html.theme--documenter-dark .table td.is-dark,html.theme--documenter-dark .table th.is-dark{background-color:#282f2f;border-color:#282f2f;color:#ecf0f1}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:#024c7d;border-color:#024c7d;color:#fff}html.theme--documenter-dark .table td.is-success,html.theme--documenter-dark .table th.is-success{background-color:#008438;border-color:#008438;color:#fff}html.theme--documenter-dark .table td.is-warning,html.theme--documenter-dark .table th.is-warning{background-color:#ad8100;border-color:#ad8100;color:#fff}html.theme--documenter-dark .table td.is-danger,html.theme--documenter-dark .table th.is-danger{background-color:#9e1b0d;border-color:#9e1b0d;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 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:0.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:15px}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-bottom-left-radius:0;border-top-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-bottom-right-radius:0;border-top-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:.85em;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:0.25rem;margin-right:-0.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:#282f2f}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:#ecf0f1}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-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-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:#024c7d;color:#fff}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:#008438;color:#fff}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:#ad8100;color:#fff}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:#9e1b0d;color:#fff}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:.85em}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:15px}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:-0.375em;margin-right:0.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:0.1875em;margin-right:-0.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:-0.375em;margin-right:-0.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:290486px}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+.highlight{margin-top:-0.75rem}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:15px}html.theme--documenter-dark .title.is-7{font-size:.85em}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:15px}html.theme--documenter-dark .subtitle.is-7{font-size:.85em}html.theme--documenter-dark .heading{display:block;font-size:11px;letter-spacing:1px;margin-bottom:5px;text-transform:uppercase}html.theme--documenter-dark .highlight{font-weight:400;max-width:100%;overflow:hidden;padding:0}html.theme--documenter-dark .highlight pre{overflow:auto;max-width:100%}html.theme--documenter-dark .number{align-items:center;background-color:#282f2f;border-radius:290486px;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:rgba(219,222,224,0.3)}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:rgba(219,222,224,0.3)}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:rgba(219,222,224,0.3)}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:rgba(219,222,224,0.3)}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 1px 2px rgba(10,10,10,0.1);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:#024c7d}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(2,76,125,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:#008438}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(0,132,56,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:#ad8100}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(173,129,0,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:#9e1b0d}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(158,27,13,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:.85em}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:290486px;padding-left:1em;padding-right:1em}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:0.625em;resize:vertical}html.theme--documenter-dark .textarea:not([rows]){max-height:600px;min-height:120px}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{color:#fff;cursor:not-allowed}html.theme--documenter-dark .radio+.radio{margin-left:0.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.25em}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:290486px;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:#024c7d}html.theme--documenter-dark .select.is-info select{border-color:#024c7d}html.theme--documenter-dark .select.is-info select:hover,html.theme--documenter-dark .select.is-info select.is-hovered{border-color:#023d64}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(2,76,125,0.25)}html.theme--documenter-dark .select.is-success:not(:hover)::after{border-color:#008438}html.theme--documenter-dark .select.is-success select{border-color:#008438}html.theme--documenter-dark .select.is-success select:hover,html.theme--documenter-dark .select.is-success select.is-hovered{border-color:#006b2d}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(0,132,56,0.25)}html.theme--documenter-dark .select.is-warning:not(:hover)::after{border-color:#ad8100}html.theme--documenter-dark .select.is-warning select{border-color:#ad8100}html.theme--documenter-dark .select.is-warning select:hover,html.theme--documenter-dark .select.is-warning select.is-hovered{border-color:#946e00}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(173,129,0,0.25)}html.theme--documenter-dark .select.is-danger:not(:hover)::after{border-color:#9e1b0d}html.theme--documenter-dark .select.is-danger select{border-color:#9e1b0d}html.theme--documenter-dark .select.is-danger select:hover,html.theme--documenter-dark .select.is-danger select.is-hovered{border-color:#86170b}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(158,27,13,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:.85em}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}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:0.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:.85em}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:#282f2f}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:#282f2f}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:#282f2f}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:#282f2f}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:#ecf0f1}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:#ecf0f1}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:#ecf0f1}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:#ecf0f1}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:#024c7d;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:#024470;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(2,76,125,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:#023d64;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-success .file-cta{background-color:#008438;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:#073;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(0,132,56,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:#006b2d;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-warning .file-cta{background-color:#ad8100;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-warning:hover .file-cta,html.theme--documenter-dark .file.is-warning.is-hovered .file-cta{background-color:#a07700;border-color:transparent;color:#fff}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(173,129,0,0.25);color:#fff}html.theme--documenter-dark .file.is-warning:active .file-cta,html.theme--documenter-dark .file.is-warning.is-active .file-cta{background-color:#946e00;border-color:transparent;color:#fff}html.theme--documenter-dark .file.is-danger .file-cta{background-color:#9e1b0d;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:#92190c;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(158,27,13,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:#86170b;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:.85em}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:#e5eaec;color:#282f2f}html.theme--documenter-dark .file-label:hover .file-name{border-color:#596668}html.theme--documenter-dark .file-label:active .file-cta{background-color:#dde4e6;color:#282f2f}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:#ecf0f1;color:#343c3d}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:left;text-overflow:ellipsis}html.theme--documenter-dark .file-icon{align-items:center;display:flex;height:1em;justify-content:center;margin-right:0.5em;width:1em}html.theme--documenter-dark .file-icon .fa{font-size:14px}html.theme--documenter-dark .label{color:#282f2f;display:block;font-size:15px;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:.85em}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:.85em;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:#024c7d}html.theme--documenter-dark .help.is-success{color:#008438}html.theme--documenter-dark .help.is-warning{color:#ad8100}html.theme--documenter-dark .help.is-danger{color:#9e1b0d}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:0.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:.85em;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:0.75rem}}html.theme--documenter-dark .control{box-sizing:border-box;clear:both;font-size:15px;position:relative;text-align:left}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:#5e6d6f}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:.85em}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:#dbdee0;height:2.25em;pointer-events:none;position:absolute;top:0;width:2.25em;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.25em}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.25em}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:0.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:.85em}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:15px;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:0.5em}html.theme--documenter-dark .breadcrumb .icon:last-child{margin-left:0.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:.85em}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;box-shadow:0 2px 3px rgba(10,10,10,0.1),0 0 0 1px rgba(10,10,10,0.1);color:#fff;max-width:100%;position:relative}html.theme--documenter-dark .card-header{background-color:rgba(0,0,0,0);align-items:stretch;box-shadow:0 1px 2px 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:.75rem}html.theme--documenter-dark .card-header-title.is-centered{justify-content:center}html.theme--documenter-dark .card-header-icon{align-items:center;cursor:pointer;display:flex;justify-content:center;padding:.75rem}html.theme--documenter-dark .card-image{display:block;position:relative}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 #5e6d6f;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 #5e6d6f}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:0 2px 3px rgba(10,10,10,0.1),0 0 0 1px rgba(10,10,10,0.1);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:left;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:#5e6d6f;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 .list{background-color:#fff;border-radius:.4em;box-shadow:0 2px 3px rgba(10,10,10,0.1),0 0 0 1px rgba(10,10,10,0.1)}html.theme--documenter-dark .list-item{display:block;padding:0.5em 1em}html.theme--documenter-dark .list-item:not(a){color:#fff}html.theme--documenter-dark .list-item:first-child{border-top-left-radius:.4em;border-top-right-radius:.4em}html.theme--documenter-dark .list-item:last-child{border-bottom-left-radius:.4em;border-bottom-right-radius:.4em}html.theme--documenter-dark .list-item:not(:last-child){border-bottom:1px solid #5e6d6f}html.theme--documenter-dark .list-item.is-active{background-color:#1abc9c;color:#fff}html.theme--documenter-dark a.list-item{background-color:#282f2f;cursor:pointer}html.theme--documenter-dark .media{align-items:flex-start;display:flex;text-align:left}html.theme--documenter-dark .media .content:not(:last-child){margin-bottom:0.75rem}html.theme--documenter-dark .media .media{border-top:1px solid rgba(94,109,111,0.5);display:flex;padding-top:0.75rem}html.theme--documenter-dark .media .media .content:not(:last-child),html.theme--documenter-dark .media .media .control:not(:last-child){margin-bottom:0.5rem}html.theme--documenter-dark .media .media .media{padding-top:0.5rem}html.theme--documenter-dark .media .media .media+.media{margin-top:0.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:left}@media screen and (max-width: 768px){html.theme--documenter-dark .media-content{overflow-x:auto}}html.theme--documenter-dark .menu{font-size:15px}html.theme--documenter-dark .menu.is-small,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.menu{font-size:.85em}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:15px}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:.85em}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;color:#4d4d4d}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;color:#090909}html.theme--documenter-dark .message.is-light{background-color:#f9fafb}html.theme--documenter-dark .message.is-light .message-header{background-color:#ecf0f1;color:#282f2f}html.theme--documenter-dark .message.is-light .message-body{border-color:#ecf0f1;color:#505050}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:#ecf0f1}html.theme--documenter-dark .message.is-dark .message-body,html.theme--documenter-dark .content kbd.message .message-body{border-color:#282f2f;color:#212526}html.theme--documenter-dark .message.is-primary,html.theme--documenter-dark .docstring>section>a.message.docs-sourcelink{background-color:#f8fafc}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:#2b4159}html.theme--documenter-dark .message.is-link{background-color:#f6fefc}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:#0b2f28}html.theme--documenter-dark .message.is-info{background-color:#f5fbff}html.theme--documenter-dark .message.is-info .message-header{background-color:#024c7d;color:#fff}html.theme--documenter-dark .message.is-info .message-body{border-color:#024c7d;color:#033659}html.theme--documenter-dark .message.is-success{background-color:#f5fff9}html.theme--documenter-dark .message.is-success .message-header{background-color:#008438;color:#fff}html.theme--documenter-dark .message.is-success .message-body{border-color:#008438;color:#023518}html.theme--documenter-dark .message.is-warning{background-color:#fffcf5}html.theme--documenter-dark .message.is-warning .message-header{background-color:#ad8100;color:#fff}html.theme--documenter-dark .message.is-warning .message-body{border-color:#ad8100;color:#3d2e03}html.theme--documenter-dark .message.is-danger{background-color:#fef6f6}html.theme--documenter-dark .message.is-danger .message-header{background-color:#9e1b0d;color:#fff}html.theme--documenter-dark .message.is-danger .message-body{border-color:#9e1b0d;color:#7a170c}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:0.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),print{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:0.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:#282f2f}html.theme--documenter-dark .navbar.is-light .navbar-brand>.navbar-item,html.theme--documenter-dark .navbar.is-light .navbar-brand .navbar-link{color:#282f2f}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:#282f2f}html.theme--documenter-dark .navbar.is-light .navbar-brand .navbar-link::after{border-color:#282f2f}html.theme--documenter-dark .navbar.is-light .navbar-burger{color:#282f2f}@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:#282f2f}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:#282f2f}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:#282f2f}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:#282f2f}html.theme--documenter-dark .navbar.is-light .navbar-dropdown a.navbar-item.is-active{background-color:#ecf0f1;color:#282f2f}}html.theme--documenter-dark .navbar.is-dark,html.theme--documenter-dark .content kbd.navbar{background-color:#282f2f;color:#ecf0f1}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:#ecf0f1}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:#ecf0f1}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:#ecf0f1}html.theme--documenter-dark .navbar.is-dark .navbar-burger,html.theme--documenter-dark .content kbd.navbar .navbar-burger{color:#ecf0f1}@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:#ecf0f1}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:#ecf0f1}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:#ecf0f1}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:#ecf0f1}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:#ecf0f1}}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:#024c7d;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:#023d64;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:#023d64;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:#023d64;color:#fff}html.theme--documenter-dark .navbar.is-info .navbar-dropdown a.navbar-item.is-active{background-color:#024c7d;color:#fff}}html.theme--documenter-dark .navbar.is-success{background-color:#008438;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:#006b2d;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:#006b2d;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:#006b2d;color:#fff}html.theme--documenter-dark .navbar.is-success .navbar-dropdown a.navbar-item.is-active{background-color:#008438;color:#fff}}html.theme--documenter-dark .navbar.is-warning{background-color:#ad8100;color:#fff}html.theme--documenter-dark .navbar.is-warning .navbar-brand>.navbar-item,html.theme--documenter-dark .navbar.is-warning .navbar-brand .navbar-link{color:#fff}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:#946e00;color:#fff}html.theme--documenter-dark .navbar.is-warning .navbar-brand .navbar-link::after{border-color:#fff}html.theme--documenter-dark .navbar.is-warning .navbar-burger{color:#fff}@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:#fff}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:#946e00;color:#fff}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:#fff}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:#946e00;color:#fff}html.theme--documenter-dark .navbar.is-warning .navbar-dropdown a.navbar-item.is-active{background-color:#ad8100;color:#fff}}html.theme--documenter-dark .navbar.is-danger{background-color:#9e1b0d;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:#86170b;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:#86170b;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:#86170b;color:#fff}html.theme--documenter-dark .navbar.is-danger .navbar-dropdown a.navbar-item.is-active{background-color:#9e1b0d;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;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{display:block;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{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:15px;margin:-.25rem}html.theme--documenter-dark .pagination.is-small,html.theme--documenter-dark #documenter .docs-sidebar form.docs-search>input.pagination{font-size:.85em}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:290486px}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:290486px}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.25em}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-next[disabled],html.theme--documenter-dark .pagination-link[disabled]{background-color:#dbdee0;border-color:#dbdee0;box-shadow:none;color:#5e6d6f;opacity:0.5}html.theme--documenter-dark .pagination-previous,html.theme--documenter-dark .pagination-next{padding-left:0.75em;padding-right:0.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}@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{order:2}html.theme--documenter-dark .pagination-next{order:3}html.theme--documenter-dark .pagination{justify-content:space-between}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{font-size:15px}html.theme--documenter-dark .panel:not(:last-child){margin-bottom:1.5rem}html.theme--documenter-dark .panel-heading,html.theme--documenter-dark .panel-tabs,html.theme--documenter-dark .panel-block{border-bottom:1px solid #5e6d6f;border-left:1px solid #5e6d6f;border-right:1px solid #5e6d6f}html.theme--documenter-dark .panel-heading:first-child,html.theme--documenter-dark .panel-tabs:first-child,html.theme--documenter-dark .panel-block:first-child{border-top:1px solid #5e6d6f}html.theme--documenter-dark .panel-heading{background-color:#282f2f;border-radius:.4em .4em 0 0;color:#f2f2f2;font-size:1.25em;font-weight:300;line-height:1.25;padding:0.5em 0.75em}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:0.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 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:0.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:15px;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:0.5em}html.theme--documenter-dark .tabs .icon:last-child{margin-left:0.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-radius:.4em 0 0 .4em}html.theme--documenter-dark .tabs.is-toggle li:last-child a{border-radius:0 .4em .4em 0}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:290486px;border-top-left-radius:290486px;padding-left:1.25em}html.theme--documenter-dark .tabs.is-toggle.is-toggle-rounded li:last-child a{border-bottom-right-radius:290486px;border-top-right-radius:290486px;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:.85em}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}.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.3333333333%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-1{margin-left:8.3333333333%}.columns.is-mobile>html.theme--documenter-dark .column.is-2{flex:none;width:16.6666666667%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-2{margin-left:16.6666666667%}.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.3333333333%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-4{margin-left:33.3333333333%}.columns.is-mobile>html.theme--documenter-dark .column.is-5{flex:none;width:41.6666666667%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-5{margin-left:41.6666666667%}.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.3333333333%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-7{margin-left:58.3333333333%}.columns.is-mobile>html.theme--documenter-dark .column.is-8{flex:none;width:66.6666666667%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-8{margin-left:66.6666666667%}.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.3333333333%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-10{margin-left:83.3333333333%}.columns.is-mobile>html.theme--documenter-dark .column.is-11{flex:none;width:91.6666666667%}.columns.is-mobile>html.theme--documenter-dark .column.is-offset-11{margin-left:91.6666666667%}.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}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.3333333333%}html.theme--documenter-dark .column.is-offset-1-mobile{margin-left:8.3333333333%}html.theme--documenter-dark .column.is-2-mobile{flex:none;width:16.6666666667%}html.theme--documenter-dark .column.is-offset-2-mobile{margin-left:16.6666666667%}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.3333333333%}html.theme--documenter-dark .column.is-offset-4-mobile{margin-left:33.3333333333%}html.theme--documenter-dark .column.is-5-mobile{flex:none;width:41.6666666667%}html.theme--documenter-dark .column.is-offset-5-mobile{margin-left:41.6666666667%}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.3333333333%}html.theme--documenter-dark .column.is-offset-7-mobile{margin-left:58.3333333333%}html.theme--documenter-dark .column.is-8-mobile{flex:none;width:66.6666666667%}html.theme--documenter-dark .column.is-offset-8-mobile{margin-left:66.6666666667%}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.3333333333%}html.theme--documenter-dark .column.is-offset-10-mobile{margin-left:83.3333333333%}html.theme--documenter-dark .column.is-11-mobile{flex:none;width:91.6666666667%}html.theme--documenter-dark .column.is-offset-11-mobile{margin-left:91.6666666667%}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}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.3333333333%}html.theme--documenter-dark .column.is-offset-1,html.theme--documenter-dark .column.is-offset-1-tablet{margin-left:8.3333333333%}html.theme--documenter-dark .column.is-2,html.theme--documenter-dark .column.is-2-tablet{flex:none;width:16.6666666667%}html.theme--documenter-dark .column.is-offset-2,html.theme--documenter-dark .column.is-offset-2-tablet{margin-left:16.6666666667%}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.3333333333%}html.theme--documenter-dark .column.is-offset-4,html.theme--documenter-dark .column.is-offset-4-tablet{margin-left:33.3333333333%}html.theme--documenter-dark .column.is-5,html.theme--documenter-dark .column.is-5-tablet{flex:none;width:41.6666666667%}html.theme--documenter-dark .column.is-offset-5,html.theme--documenter-dark .column.is-offset-5-tablet{margin-left:41.6666666667%}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.3333333333%}html.theme--documenter-dark .column.is-offset-7,html.theme--documenter-dark .column.is-offset-7-tablet{margin-left:58.3333333333%}html.theme--documenter-dark .column.is-8,html.theme--documenter-dark .column.is-8-tablet{flex:none;width:66.6666666667%}html.theme--documenter-dark .column.is-offset-8,html.theme--documenter-dark .column.is-offset-8-tablet{margin-left:66.6666666667%}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.3333333333%}html.theme--documenter-dark .column.is-offset-10,html.theme--documenter-dark .column.is-offset-10-tablet{margin-left:83.3333333333%}html.theme--documenter-dark .column.is-11,html.theme--documenter-dark .column.is-11-tablet{flex:none;width:91.6666666667%}html.theme--documenter-dark .column.is-offset-11,html.theme--documenter-dark .column.is-offset-11-tablet{margin-left:91.6666666667%}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}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.3333333333%}html.theme--documenter-dark .column.is-offset-1-touch{margin-left:8.3333333333%}html.theme--documenter-dark .column.is-2-touch{flex:none;width:16.6666666667%}html.theme--documenter-dark .column.is-offset-2-touch{margin-left:16.6666666667%}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.3333333333%}html.theme--documenter-dark .column.is-offset-4-touch{margin-left:33.3333333333%}html.theme--documenter-dark .column.is-5-touch{flex:none;width:41.6666666667%}html.theme--documenter-dark .column.is-offset-5-touch{margin-left:41.6666666667%}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.3333333333%}html.theme--documenter-dark .column.is-offset-7-touch{margin-left:58.3333333333%}html.theme--documenter-dark .column.is-8-touch{flex:none;width:66.6666666667%}html.theme--documenter-dark .column.is-offset-8-touch{margin-left:66.6666666667%}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.3333333333%}html.theme--documenter-dark .column.is-offset-10-touch{margin-left:83.3333333333%}html.theme--documenter-dark .column.is-11-touch{flex:none;width:91.6666666667%}html.theme--documenter-dark .column.is-offset-11-touch{margin-left:91.6666666667%}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}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.3333333333%}html.theme--documenter-dark .column.is-offset-1-desktop{margin-left:8.3333333333%}html.theme--documenter-dark .column.is-2-desktop{flex:none;width:16.6666666667%}html.theme--documenter-dark .column.is-offset-2-desktop{margin-left:16.6666666667%}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.3333333333%}html.theme--documenter-dark .column.is-offset-4-desktop{margin-left:33.3333333333%}html.theme--documenter-dark .column.is-5-desktop{flex:none;width:41.6666666667%}html.theme--documenter-dark .column.is-offset-5-desktop{margin-left:41.6666666667%}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.3333333333%}html.theme--documenter-dark .column.is-offset-7-desktop{margin-left:58.3333333333%}html.theme--documenter-dark .column.is-8-desktop{flex:none;width:66.6666666667%}html.theme--documenter-dark .column.is-offset-8-desktop{margin-left:66.6666666667%}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.3333333333%}html.theme--documenter-dark .column.is-offset-10-desktop{margin-left:83.3333333333%}html.theme--documenter-dark .column.is-11-desktop{flex:none;width:91.6666666667%}html.theme--documenter-dark .column.is-offset-11-desktop{margin-left:91.6666666667%}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}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.3333333333%}html.theme--documenter-dark .column.is-offset-1-widescreen{margin-left:8.3333333333%}html.theme--documenter-dark .column.is-2-widescreen{flex:none;width:16.6666666667%}html.theme--documenter-dark .column.is-offset-2-widescreen{margin-left:16.6666666667%}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.3333333333%}html.theme--documenter-dark .column.is-offset-4-widescreen{margin-left:33.3333333333%}html.theme--documenter-dark .column.is-5-widescreen{flex:none;width:41.6666666667%}html.theme--documenter-dark .column.is-offset-5-widescreen{margin-left:41.6666666667%}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.3333333333%}html.theme--documenter-dark .column.is-offset-7-widescreen{margin-left:58.3333333333%}html.theme--documenter-dark .column.is-8-widescreen{flex:none;width:66.6666666667%}html.theme--documenter-dark .column.is-offset-8-widescreen{margin-left:66.6666666667%}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.3333333333%}html.theme--documenter-dark .column.is-offset-10-widescreen{margin-left:83.3333333333%}html.theme--documenter-dark .column.is-11-widescreen{flex:none;width:91.6666666667%}html.theme--documenter-dark .column.is-offset-11-widescreen{margin-left:91.6666666667%}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}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.3333333333%}html.theme--documenter-dark .column.is-offset-1-fullhd{margin-left:8.3333333333%}html.theme--documenter-dark .column.is-2-fullhd{flex:none;width:16.6666666667%}html.theme--documenter-dark .column.is-offset-2-fullhd{margin-left:16.6666666667%}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.3333333333%}html.theme--documenter-dark .column.is-offset-4-fullhd{margin-left:33.3333333333%}html.theme--documenter-dark .column.is-5-fullhd{flex:none;width:41.6666666667%}html.theme--documenter-dark .column.is-offset-5-fullhd{margin-left:41.6666666667%}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.3333333333%}html.theme--documenter-dark .column.is-offset-7-fullhd{margin-left:58.3333333333%}html.theme--documenter-dark .column.is-8-fullhd{flex:none;width:66.6666666667%}html.theme--documenter-dark .column.is-offset-8-fullhd{margin-left:66.6666666667%}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.3333333333%}html.theme--documenter-dark .column.is-offset-10-fullhd{margin-left:83.3333333333%}html.theme--documenter-dark .column.is-11-fullhd{flex:none;width:91.6666666667%}html.theme--documenter-dark .column.is-offset-11-fullhd{margin-left:91.6666666667%}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.3333333333%}html.theme--documenter-dark .tile.is-2{flex:none;width:16.6666666667%}html.theme--documenter-dark .tile.is-3{flex:none;width:25%}html.theme--documenter-dark .tile.is-4{flex:none;width:33.3333333333%}html.theme--documenter-dark .tile.is-5{flex:none;width:41.6666666667%}html.theme--documenter-dark .tile.is-6{flex:none;width:50%}html.theme--documenter-dark .tile.is-7{flex:none;width:58.3333333333%}html.theme--documenter-dark .tile.is-8{flex:none;width:66.6666666667%}html.theme--documenter-dark .tile.is-9{flex:none;width:75%}html.theme--documenter-dark .tile.is-10{flex:none;width:83.3333333333%}html.theme--documenter-dark .tile.is-11{flex:none;width:91.6666666667%}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{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{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:#282f2f}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:#282f2f}html.theme--documenter-dark .hero.is-light .subtitle{color:rgba(40,47,47,0.9)}html.theme--documenter-dark .hero.is-light .subtitle a:not(.button),html.theme--documenter-dark .hero.is-light .subtitle strong{color:#282f2f}@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(40,47,47,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:#282f2f}html.theme--documenter-dark .hero.is-light .tabs a{color:#282f2f;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{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:#282f2f}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:#282f2f;border-color:#282f2f;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:#ecf0f1}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:#ecf0f1}html.theme--documenter-dark .hero.is-dark .subtitle,html.theme--documenter-dark .content kbd.hero .subtitle{color:rgba(236,240,241,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:#ecf0f1}@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(236,240,241,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:#ecf0f1}html.theme--documenter-dark .hero.is-dark .tabs a,html.theme--documenter-dark .content kbd.hero .tabs a{color:#ecf0f1;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{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:#ecf0f1}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:#ecf0f1;border-color:#ecf0f1;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{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{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:#024c7d;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:#024c7d}}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:#023d64;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{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:#024c7d}html.theme--documenter-dark .hero.is-info.is-bold{background-image:linear-gradient(141deg, #003a4c 0%, #024c7d 71%, #004299 100%)}@media screen and (max-width: 768px){html.theme--documenter-dark .hero.is-info.is-bold .navbar-menu{background-image:linear-gradient(141deg, #003a4c 0%, #024c7d 71%, #004299 100%)}}html.theme--documenter-dark .hero.is-success{background-color:#008438;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:#008438}}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:#006b2d;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{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:#008438}html.theme--documenter-dark .hero.is-success.is-bold{background-image:linear-gradient(141deg, #005115 0%, #008438 71%, #009e5d 100%)}@media screen and (max-width: 768px){html.theme--documenter-dark .hero.is-success.is-bold .navbar-menu{background-image:linear-gradient(141deg, #005115 0%, #008438 71%, #009e5d 100%)}}html.theme--documenter-dark .hero.is-warning{background-color:#ad8100;color:#fff}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:#fff}html.theme--documenter-dark .hero.is-warning .subtitle{color:rgba(255,255,255,0.9)}html.theme--documenter-dark .hero.is-warning .subtitle a:not(.button),html.theme--documenter-dark .hero.is-warning .subtitle strong{color:#fff}@media screen and (max-width: 1055px){html.theme--documenter-dark .hero.is-warning .navbar-menu{background-color:#ad8100}}html.theme--documenter-dark .hero.is-warning .navbar-item,html.theme--documenter-dark .hero.is-warning .navbar-link{color:rgba(255,255,255,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:#946e00;color:#fff}html.theme--documenter-dark .hero.is-warning .tabs a{color:#fff;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{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:#fff}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:#fff;border-color:#fff;color:#ad8100}html.theme--documenter-dark .hero.is-warning.is-bold{background-image:linear-gradient(141deg, #7a4700 0%, #ad8100 71%, #c7b500 100%)}@media screen and (max-width: 768px){html.theme--documenter-dark .hero.is-warning.is-bold .navbar-menu{background-image:linear-gradient(141deg, #7a4700 0%, #ad8100 71%, #c7b500 100%)}}html.theme--documenter-dark .hero.is-danger{background-color:#9e1b0d;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:#9e1b0d}}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:#86170b;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{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:#9e1b0d}html.theme--documenter-dark .hero.is-danger.is-bold{background-image:linear-gradient(141deg, #75030b 0%, #9e1b0d 71%, #ba380a 100%)}@media screen and (max-width: 768px){html.theme--documenter-dark .hero.is-danger.is-bold .navbar-menu{background-image:linear-gradient(141deg, #75030b 0%, #9e1b0d 71%, #ba380a 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-bottom:1.5rem;padding-top:1.5rem}@media screen and (min-width: 769px),print{html.theme--documenter-dark .hero.is-medium .hero-body{padding-bottom:9rem;padding-top:9rem}}@media screen and (min-width: 769px),print{html.theme--documenter-dark .hero.is-large .hero-body{padding-bottom:18rem;padding-top:18rem}}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}html.theme--documenter-dark .section{padding:3rem 1.5rem}@media screen and (min-width: 1056px){html.theme--documenter-dark .section.is-medium{padding:9rem 1.5rem}html.theme--documenter-dark .section.is-large{padding:18rem 1.5rem}}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:#0363a3}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:#024c7d;box-shadow:0 0 0 2px rgba(2,76,125,0.5)}html.theme--documenter-dark .button.is-success.is-hovered,html.theme--documenter-dark .button.is-success:hover{background-color:#00aa48}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:#008438;box-shadow:0 0 0 2px rgba(0,132,56,0.5)}html.theme--documenter-dark .button.is-warning.is-hovered,html.theme--documenter-dark .button.is-warning:hover{background-color:#d39e00}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:#ad8100;box-shadow:0 0 0 2px rgba(173,129,0,0.5)}html.theme--documenter-dark .button.is-danger.is-hovered,html.theme--documenter-dark .button.is-danger:hover{background-color:#c12110}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:#9e1b0d;box-shadow:0 0 0 2px rgba(158,27,13,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:#282f2f;text-decoration:underline}html.theme--documenter-dark .notification.is-dark a:not(.button),html.theme--documenter-dark .content kbd.notification a:not(.button){color:#ecf0f1;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:#fff;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 5 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 5 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:1px;border-color:#5e6d6f;border-radius:.4em;font-size:15px}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:.85em}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:#5e6d6f}html.theme--documenter-dark .admonition.is-default>.admonition-header{background-color:#5e6d6f;color:#fff}html.theme--documenter-dark .admonition.is-default>.admonition-body{color:#fff}html.theme--documenter-dark .admonition.is-info{background-color:#282f2f;border-color:#024c7d}html.theme--documenter-dark .admonition.is-info>.admonition-header{background-color:#024c7d;color:#fff}html.theme--documenter-dark .admonition.is-info>.admonition-body{color:#fff}html.theme--documenter-dark .admonition.is-success{background-color:#282f2f;border-color:#008438}html.theme--documenter-dark .admonition.is-success>.admonition-header{background-color:#008438;color:#fff}html.theme--documenter-dark .admonition.is-success>.admonition-body{color:#fff}html.theme--documenter-dark .admonition.is-warning{background-color:#282f2f;border-color:#ad8100}html.theme--documenter-dark .admonition.is-warning>.admonition-header{background-color:#ad8100;color:#fff}html.theme--documenter-dark .admonition.is-warning>.admonition-body{color:#fff}html.theme--documenter-dark .admonition.is-danger{background-color:#282f2f;border-color:#9e1b0d}html.theme--documenter-dark .admonition.is-danger>.admonition-header{background-color:#9e1b0d;color:#fff}html.theme--documenter-dark .admonition.is-danger>.admonition-body{color:#fff}html.theme--documenter-dark .admonition.is-compat{background-color:#282f2f;border-color:#137886}html.theme--documenter-dark .admonition.is-compat>.admonition-header{background-color:#137886;color:#fff}html.theme--documenter-dark .admonition.is-compat>.admonition-body{color:#fff}html.theme--documenter-dark .admonition-header{color:#fff;background-color:#5e6d6f;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 5 Free";font-weight:900;margin-right:.75rem;content:"\f06a"}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:1px solid #5e6d6f;box-shadow:none;max-width:100%}html.theme--documenter-dark .docstring>header{display:flex;flex-grow:1;align-items:stretch;padding:0.5rem .75rem;background-color:#282f2f;box-shadow:0 1px 2px rgba(10,10,10,0.1);box-shadow:none;border-bottom:1px solid #5e6d6f}html.theme--documenter-dark .docstring>header code{background-color:transparent}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 #9e1b0d;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:1px solid #5e6d6f}html.theme--documenter-dark .content code{font-weight:inherit}html.theme--documenter-dark .content a code{color:#1abc9c}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}html.theme--documenter-dark #documenter .docs-main header.docs-navbar .docs-right{display:flex;white-space:nowrap}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,html.theme--documenter-dark #documenter .docs-main header.docs-navbar .docs-right .docs-sidebar-button{display:inline-block}html.theme--documenter-dark #documenter .docs-main header.docs-navbar .docs-right .docs-label{padding:0;margin-left:0.3em}html.theme--documenter-dark #documenter .docs-main header.docs-navbar .docs-right .docs-settings-button{margin:auto 0 auto 1rem}html.theme--documenter-dark #documenter .docs-main header.docs-navbar .docs-right .docs-sidebar-button{font-size:1.5rem;margin:auto 0 auto 1rem}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:15px;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:14.25px;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:11.25px;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 5 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:12.75px;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}@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 #documenter .docs-main #documenter-search-info{margin-bottom:1rem}html.theme--documenter-dark #documenter .docs-main #documenter-search-results{list-style-type:circle;list-style-position:outside}html.theme--documenter-dark #documenter .docs-main #documenter-search-results li{margin-left:2rem}html.theme--documenter-dark #documenter .docs-main #documenter-search-results .docs-highlight{background-color:yellow}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} diff --git a/previews/PR360/assets/themes/documenter-light.css b/previews/PR360/assets/themes/documenter-light.css new file mode 100644 index 000000000..9b9a14b04 --- /dev/null +++ b/previews/PR360/assets/themes/documenter-light.css @@ -0,0 +1,9 @@ +@keyframes spinAround{from{transform:rotate(0deg)}to{transform:rotate(359deg)}}.tabs,.pagination-previous,.pagination-next,.pagination-link,.pagination-ellipsis,.breadcrumb,.file,.button,.is-unselectable,.modal-close,.delete{-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),.message:not(:last-child),.list:not(:last-child),.level:not(:last-child),.breadcrumb:not(:last-child),.highlight: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{-moz-appearance:none;-webkit-appearance:none;background-color:rgba(10,10,10,0.2);border:none;border-radius:290486px;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:290486px;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}.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.25em;justify-content:flex-start;line-height:1.5;padding-bottom:calc(0.375em - 1px);padding-left:calc(0.625em - 1px);padding-right:calc(0.625em - 1px);padding-top:calc(0.375em - 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}/*! minireset.css v0.0.4 | 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,embed,iframe,object,video{height:auto;max-width:100%}audio{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:left}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,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:left}table th{color:#222}.is-clearfix::after{clear:both;content:" ";display:table}.is-pulled-left{float:left !important}.is-pulled-right{float:right !important}.is-clipped{overflow:hidden !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}.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-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-info{color:#209cee !important}a.has-text-info:hover,a.has-text-info:focus{color:#1081cb !important}.has-background-info{background-color:#209cee !important}.has-text-success{color:#22c35b !important}a.has-text-success:hover,a.has-text-success:focus{color:#1a9847 !important}.has-background-success{background-color:#22c35b !important}.has-text-warning{color:#ffdd57 !important}a.has-text-warning:hover,a.has-text-warning:focus{color:#ffd324 !important}.has-background-warning{background-color:#ffdd57 !important}.has-text-danger{color:#da0b00 !important}a.has-text-danger:hover,a.has-text-danger:focus{color:#a70800 !important}.has-background-danger{background-color:#da0b00 !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}.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}}.is-marginless{margin:0 !important}.is-paddingless{padding:0 !important}.is-radiusless{border-radius:0 !important}.is-shadowless{box-shadow:none !important}.is-relative{position:relative !important}.box{background-color:#fff;border-radius:6px;box-shadow:0 2px 3px rgba(10,10,10,0.1),0 0 0 1px rgba(10,10,10,0.1);color:#222;display:block;padding:1.25rem}a.box:hover,a.box:focus{box-shadow:0 2px 3px 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:#363636;cursor:pointer;justify-content:center;padding-bottom:calc(0.375em - 1px);padding-left:.75em;padding-right:.75em;padding-top:calc(0.375em - 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.375em - 1px);margin-right:0.1875em}.button .icon:last-child:not(:first-child){margin-left:0.1875em;margin-right:calc(-0.375em - 1px)}.button .icon:first-child:last-child{margin-left:calc(-0.375em - 1px);margin-right:calc(-0.375em - 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-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:transparent;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:transparent;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:#363636}.button.is-light:hover,.button.is-light.is-hovered{background-color:#eee;border-color:transparent;color:#363636}.button.is-light:focus,.button.is-light.is-focused{border-color:transparent;color:#363636}.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:#363636}.button.is-light[disabled],fieldset[disabled] .button.is-light{background-color:#f5f5f5;border-color:transparent;box-shadow:none}.button.is-light.is-inverted{background-color:#363636;color:#f5f5f5}.button.is-light.is-inverted:hover,.button.is-light.is-inverted.is-hovered{background-color:#292929}.button.is-light.is-inverted[disabled],fieldset[disabled] .button.is-light.is-inverted{background-color:#363636;border-color:transparent;box-shadow:none;color:#f5f5f5}.button.is-light.is-loading::after{border-color:transparent transparent #363636 #363636 !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:#363636}.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 #363636 #363636 !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:#363636;color:#363636}.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:#363636;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:#363636;box-shadow:none;color:#363636}.button.is-dark,.content kbd.button{background-color:#363636;border-color:transparent;color:#f5f5f5}.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:#f5f5f5}.button.is-dark:focus,.content kbd.button:focus,.button.is-dark.is-focused,.content kbd.button.is-focused{border-color:transparent;color:#f5f5f5}.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:#f5f5f5}.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:transparent;box-shadow:none}.button.is-dark.is-inverted,.content kbd.button.is-inverted{background-color:#f5f5f5;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:#e8e8e8}.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:#f5f5f5;border-color:transparent;box-shadow:none;color:#363636}.button.is-dark.is-loading::after,.content kbd.button.is-loading::after{border-color:transparent transparent #f5f5f5 #f5f5f5 !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:#f5f5f5}.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 #f5f5f5 #f5f5f5 !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:#f5f5f5;color:#f5f5f5}.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:#f5f5f5;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:#f5f5f5;box-shadow:none;color:#f5f5f5}.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:transparent;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-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:transparent;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-info{background-color:#209cee;border-color:transparent;color:#fff}.button.is-info:hover,.button.is-info.is-hovered{background-color:#1497ed;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(32,156,238,0.25)}.button.is-info:active,.button.is-info.is-active{background-color:#1190e3;border-color:transparent;color:#fff}.button.is-info[disabled],fieldset[disabled] .button.is-info{background-color:#209cee;border-color:transparent;box-shadow:none}.button.is-info.is-inverted{background-color:#fff;color:#209cee}.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:#209cee}.button.is-info.is-loading::after{border-color:transparent transparent #fff #fff !important}.button.is-info.is-outlined{background-color:transparent;border-color:#209cee;color:#209cee}.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:#209cee;border-color:#209cee;color:#fff}.button.is-info.is-outlined.is-loading::after{border-color:transparent transparent #209cee #209cee !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:#209cee;box-shadow:none;color:#209cee}.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:#209cee}.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 #209cee #209cee !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-success{background-color:#22c35b;border-color:transparent;color:#fff}.button.is-success:hover,.button.is-success.is-hovered{background-color:#20b856;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(34,195,91,0.25)}.button.is-success:active,.button.is-success.is-active{background-color:#1ead51;border-color:transparent;color:#fff}.button.is-success[disabled],fieldset[disabled] .button.is-success{background-color:#22c35b;border-color:transparent;box-shadow:none}.button.is-success.is-inverted{background-color:#fff;color:#22c35b}.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:#22c35b}.button.is-success.is-loading::after{border-color:transparent transparent #fff #fff !important}.button.is-success.is-outlined{background-color:transparent;border-color:#22c35b;color:#22c35b}.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:#22c35b;border-color:#22c35b;color:#fff}.button.is-success.is-outlined.is-loading::after{border-color:transparent transparent #22c35b #22c35b !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:#22c35b;box-shadow:none;color:#22c35b}.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:#22c35b}.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 #22c35b #22c35b !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-warning{background-color:#ffdd57;border-color:transparent;color:rgba(0,0,0,0.7)}.button.is-warning:hover,.button.is-warning.is-hovered{background-color:#ffda4a;border-color:transparent;color:rgba(0,0,0,0.7)}.button.is-warning:focus,.button.is-warning.is-focused{border-color:transparent;color:rgba(0,0,0,0.7)}.button.is-warning:focus:not(:active),.button.is-warning.is-focused:not(:active){box-shadow:0 0 0 0.125em rgba(255,221,87,0.25)}.button.is-warning:active,.button.is-warning.is-active{background-color:#ffd83e;border-color:transparent;color:rgba(0,0,0,0.7)}.button.is-warning[disabled],fieldset[disabled] .button.is-warning{background-color:#ffdd57;border-color:transparent;box-shadow:none}.button.is-warning.is-inverted{background-color:rgba(0,0,0,0.7);color:#ffdd57}.button.is-warning.is-inverted:hover,.button.is-warning.is-inverted.is-hovered{background-color:rgba(0,0,0,0.7)}.button.is-warning.is-inverted[disabled],fieldset[disabled] .button.is-warning.is-inverted{background-color:rgba(0,0,0,0.7);border-color:transparent;box-shadow:none;color:#ffdd57}.button.is-warning.is-loading::after{border-color:transparent transparent rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}.button.is-warning.is-outlined{background-color:transparent;border-color:#ffdd57;color:#ffdd57}.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:#ffdd57;border-color:#ffdd57;color:rgba(0,0,0,0.7)}.button.is-warning.is-outlined.is-loading::after{border-color:transparent transparent #ffdd57 #ffdd57 !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 rgba(0,0,0,0.7) rgba(0,0,0,0.7) !important}.button.is-warning.is-outlined[disabled],fieldset[disabled] .button.is-warning.is-outlined{background-color:transparent;border-color:#ffdd57;box-shadow:none;color:#ffdd57}.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)}.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:rgba(0,0,0,0.7);color:#ffdd57}.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 #ffdd57 #ffdd57 !important}.button.is-warning.is-inverted.is-outlined[disabled],fieldset[disabled] .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)}.button.is-danger{background-color:#da0b00;border-color:transparent;color:#fff}.button.is-danger:hover,.button.is-danger.is-hovered{background-color:#cd0a00;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(218,11,0,0.25)}.button.is-danger:active,.button.is-danger.is-active{background-color:#c10a00;border-color:transparent;color:#fff}.button.is-danger[disabled],fieldset[disabled] .button.is-danger{background-color:#da0b00;border-color:transparent;box-shadow:none}.button.is-danger.is-inverted{background-color:#fff;color:#da0b00}.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:#da0b00}.button.is-danger.is-loading::after{border-color:transparent transparent #fff #fff !important}.button.is-danger.is-outlined{background-color:transparent;border-color:#da0b00;color:#da0b00}.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:#da0b00;border-color:#da0b00;color:#fff}.button.is-danger.is-outlined.is-loading::after{border-color:transparent transparent #da0b00 #da0b00 !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:#da0b00;box-shadow:none;color:#da0b00}.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:#da0b00}.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 #da0b00 #da0b00 !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-small,#documenter .docs-sidebar form.docs-search>input.button{border-radius:2px;font-size:.75rem}.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 / 2));top:calc(50% - (1em / 2));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:290486px;padding-left:1em;padding-right:1em}.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:0.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){border-radius:2px;font-size:.75rem}.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}.container{flex-grow:1;margin:0 auto;position:relative;width:auto}@media screen and (min-width: 1056px){.container{max-width:992px}.container.is-fluid{margin-left:32px;margin-right:32px;max-width:none}}@media screen and (max-width: 1215px){.container.is-widescreen{max-width:1152px}}@media screen and (max-width: 1407px){.container.is-fullhd{max-width:1344px}}@media screen and (min-width: 1216px){.container{max-width:1152px}}@media screen and (min-width: 1408px){.container{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:left}.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-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}.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:290486px}.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;padding:1.25rem 2.5rem 1.25rem 1.5rem;position:relative}.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{position:absolute;right:0.5rem;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:#363636}.notification.is-dark,.content kbd.notification{background-color:#363636;color:#f5f5f5}.notification.is-primary,.docstring>section>a.notification.docs-sourcelink{background-color:#4eb5de;color:#fff}.notification.is-link{background-color:#2e63b8;color:#fff}.notification.is-info{background-color:#209cee;color:#fff}.notification.is-success{background-color:#22c35b;color:#fff}.notification.is-warning{background-color:#ffdd57;color:rgba(0,0,0,0.7)}.notification.is-danger{background-color:#da0b00;color:#fff}.progress{-moz-appearance:none;-webkit-appearance:none;border:none;border-radius:290486px;display:block;height:1rem;overflow:hidden;padding:0;width:100%}.progress::-webkit-progress-bar{background-color:#dbdbdb}.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%, #dbdbdb 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%, #dbdbdb 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%, #dbdbdb 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%, #dbdbdb 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%, #dbdbdb 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%, #dbdbdb 30%)}.progress.is-info::-webkit-progress-value{background-color:#209cee}.progress.is-info::-moz-progress-bar{background-color:#209cee}.progress.is-info::-ms-fill{background-color:#209cee}.progress.is-info:indeterminate{background-image:linear-gradient(to right, #209cee 30%, #dbdbdb 30%)}.progress.is-success::-webkit-progress-value{background-color:#22c35b}.progress.is-success::-moz-progress-bar{background-color:#22c35b}.progress.is-success::-ms-fill{background-color:#22c35b}.progress.is-success:indeterminate{background-image:linear-gradient(to right, #22c35b 30%, #dbdbdb 30%)}.progress.is-warning::-webkit-progress-value{background-color:#ffdd57}.progress.is-warning::-moz-progress-bar{background-color:#ffdd57}.progress.is-warning::-ms-fill{background-color:#ffdd57}.progress.is-warning:indeterminate{background-image:linear-gradient(to right, #ffdd57 30%, #dbdbdb 30%)}.progress.is-danger::-webkit-progress-value{background-color:#da0b00}.progress.is-danger::-moz-progress-bar{background-color:#da0b00}.progress.is-danger::-ms-fill{background-color:#da0b00}.progress.is-danger:indeterminate{background-image:linear-gradient(to right, #da0b00 30%, #dbdbdb 30%)}.progress:indeterminate{animation-duration:1.5s;animation-iteration-count:infinite;animation-name:moveIndeterminate;animation-timing-function:linear;background-color:#dbdbdb;background-image:linear-gradient(to right, #222 30%, #dbdbdb 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.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:#363636}.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:#363636}.table td.is-dark,.table th.is-dark{background-color:#363636;border-color:#363636;color:#f5f5f5}.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:#209cee;border-color:#209cee;color:#fff}.table td.is-success,.table th.is-success{background-color:#22c35b;border-color:#22c35b;color:#fff}.table td.is-warning,.table th.is-warning{background-color:#ffdd57;border-color:#ffdd57;color:rgba(0,0,0,0.7)}.table td.is-danger,.table th.is-danger{background-color:#da0b00;border-color:#da0b00;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 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:0.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-bottom-left-radius:0;border-top-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-bottom-right-radius:0;border-top-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:0.25rem;margin-right:-0.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:#363636}.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:#f5f5f5}.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-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-info:not(body),.content kbd.is-info:not(body),.docstring>section>a.docs-sourcelink.is-info:not(body){background-color:#209cee;color:#fff}.tag.is-success:not(body),.content kbd.is-success:not(body),.docstring>section>a.docs-sourcelink.is-success:not(body){background-color:#22c35b;color:#fff}.tag.is-warning:not(body),.content kbd.is-warning:not(body),.docstring>section>a.docs-sourcelink.is-warning:not(body){background-color:#ffdd57;color:rgba(0,0,0,0.7)}.tag.is-danger:not(body),.content kbd.is-danger:not(body),.docstring>section>a.docs-sourcelink.is-danger:not(body){background-color:#da0b00;color:#fff}.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:-0.375em;margin-right:0.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:0.1875em;margin-right:-0.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:-0.375em;margin-right:-0.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:290486px}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:#363636;font-size:2rem;font-weight:600;line-height:1.125}.title strong{color:inherit;font-weight:inherit}.title+.highlight{margin-top:-0.75rem}.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:#4a4a4a;font-size:1.25rem;font-weight:400;line-height:1.25}.subtitle strong{color:#363636;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}.highlight{font-weight:400;max-width:100%;overflow:hidden;padding:0}.highlight pre{overflow:auto;max-width:100%}.number{align-items:center;background-color:#f5f5f5;border-radius:290486px;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:#363636}.select select::-moz-placeholder,.textarea::-moz-placeholder,.input::-moz-placeholder,#documenter .docs-sidebar form.docs-search>input::-moz-placeholder{color:rgba(54,54,54,0.3)}.select select::-webkit-input-placeholder,.textarea::-webkit-input-placeholder,.input::-webkit-input-placeholder,#documenter .docs-sidebar form.docs-search>input::-webkit-input-placeholder{color:rgba(54,54,54,0.3)}.select select:-moz-placeholder,.textarea:-moz-placeholder,.input:-moz-placeholder,#documenter .docs-sidebar form.docs-search>input:-moz-placeholder{color:rgba(54,54,54,0.3)}.select select:-ms-input-placeholder,.textarea:-ms-input-placeholder,.input:-ms-input-placeholder,#documenter .docs-sidebar form.docs-search>input:-ms-input-placeholder{color:rgba(54,54,54,0.3)}.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 1px 2px rgba(10,10,10,0.1);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:#209cee}.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(32,156,238,0.25)}.is-success.textarea,.is-success.input,#documenter .docs-sidebar form.docs-search>input.is-success{border-color:#22c35b}.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(34,195,91,0.25)}.is-warning.textarea,.is-warning.input,#documenter .docs-sidebar form.docs-search>input.is-warning{border-color:#ffdd57}.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(255,221,87,0.25)}.is-danger.textarea,.is-danger.input,#documenter .docs-sidebar form.docs-search>input.is-danger{border-color:#da0b00}.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(218,11,0,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:290486px;padding-left:1em;padding-right:1em}.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:0.625em;resize:vertical}.textarea:not([rows]){max-height:600px;min-height:120px}.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:#363636}.radio[disabled],.checkbox[disabled],fieldset[disabled] .radio,fieldset[disabled] .checkbox{color:#6b6b6b;cursor:not-allowed}.radio+.radio{margin-left:0.5em}.select{display:inline-block;max-width:100%;position:relative;vertical-align:top}.select:not(.is-multiple){height:2.25em}.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:290486px;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:#363636}.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:#209cee}.select.is-info select{border-color:#209cee}.select.is-info select:hover,.select.is-info select.is-hovered{border-color:#1190e3}.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(32,156,238,0.25)}.select.is-success:not(:hover)::after{border-color:#22c35b}.select.is-success select{border-color:#22c35b}.select.is-success select:hover,.select.is-success select.is-hovered{border-color:#1ead51}.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(34,195,91,0.25)}.select.is-warning:not(:hover)::after{border-color:#ffdd57}.select.is-warning select{border-color:#ffdd57}.select.is-warning select:hover,.select.is-warning select.is-hovered{border-color:#ffd83e}.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(255,221,87,0.25)}.select.is-danger:not(:hover)::after{border-color:#da0b00}.select.is-danger select{border-color:#da0b00}.select.is-danger select:hover,.select.is-danger select.is-hovered{border-color:#c10a00}.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(218,11,0,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}.select.is-fullwidth{width:100%}.select.is-fullwidth select{width:100%}.select.is-loading::after{margin-top:0;position:absolute;right:0.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:#363636}.file.is-light:hover .file-cta,.file.is-light.is-hovered .file-cta{background-color:#eee;border-color:transparent;color:#363636}.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:#363636}.file.is-light:active .file-cta,.file.is-light.is-active .file-cta{background-color:#e8e8e8;border-color:transparent;color:#363636}.file.is-dark .file-cta,.content kbd.file .file-cta{background-color:#363636;border-color:transparent;color:#f5f5f5}.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:#f5f5f5}.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:#f5f5f5}.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:#f5f5f5}.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:#209cee;border-color:transparent;color:#fff}.file.is-info:hover .file-cta,.file.is-info.is-hovered .file-cta{background-color:#1497ed;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(32,156,238,0.25);color:#fff}.file.is-info:active .file-cta,.file.is-info.is-active .file-cta{background-color:#1190e3;border-color:transparent;color:#fff}.file.is-success .file-cta{background-color:#22c35b;border-color:transparent;color:#fff}.file.is-success:hover .file-cta,.file.is-success.is-hovered .file-cta{background-color:#20b856;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(34,195,91,0.25);color:#fff}.file.is-success:active .file-cta,.file.is-success.is-active .file-cta{background-color:#1ead51;border-color:transparent;color:#fff}.file.is-warning .file-cta{background-color:#ffdd57;border-color:transparent;color:rgba(0,0,0,0.7)}.file.is-warning:hover .file-cta,.file.is-warning.is-hovered .file-cta{background-color:#ffda4a;border-color:transparent;color:rgba(0,0,0,0.7)}.file.is-warning:focus .file-cta,.file.is-warning.is-focused .file-cta{border-color:transparent;box-shadow:0 0 0.5em rgba(255,221,87,0.25);color:rgba(0,0,0,0.7)}.file.is-warning:active .file-cta,.file.is-warning.is-active .file-cta{background-color:#ffd83e;border-color:transparent;color:rgba(0,0,0,0.7)}.file.is-danger .file-cta{background-color:#da0b00;border-color:transparent;color:#fff}.file.is-danger:hover .file-cta,.file.is-danger.is-hovered .file-cta{background-color:#cd0a00;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(218,11,0,0.25);color:#fff}.file.is-danger:active .file-cta,.file.is-danger.is-active .file-cta{background-color:#c10a00;border-color:transparent;color:#fff}.file.is-small,#documenter .docs-sidebar form.docs-search>input.file{font-size:.75rem}.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:#363636}.file-label:hover .file-name{border-color:#d5d5d5}.file-label:active .file-cta{background-color:#e8e8e8;color:#363636}.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:#4a4a4a}.file-name{border-color:#dbdbdb;border-style:solid;border-width:1px 1px 1px 0;display:block;max-width:16em;overflow:hidden;text-align:left;text-overflow:ellipsis}.file-icon{align-items:center;display:flex;height:1em;justify-content:center;margin-right:0.5em;width:1em}.file-icon .fa{font-size:14px}.label{color:#363636;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:#209cee}.help.is-success{color:#22c35b}.help.is-warning{color:#ffdd57}.help.is-danger{color:#da0b00}.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:0.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:0.75rem}}.control{box-sizing:border-box;clear:both;font-size:1rem;position:relative;text-align:left}.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:#6b6b6b}.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.25em;pointer-events:none;position:absolute;top:0;width:2.25em;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.25em}.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.25em}.control.has-icons-right .icon.is-right{right:0}.control.is-loading::after{position:absolute !important;right:0.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:0.5em}.breadcrumb .icon:last-child{margin-left:0.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;box-shadow:0 2px 3px rgba(10,10,10,0.1),0 0 0 1px rgba(10,10,10,0.1);color:#222;max-width:100%;position:relative}.card-header{background-color:rgba(0,0,0,0);align-items:stretch;box-shadow:0 1px 2px 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:.75rem}.card-header-title.is-centered{justify-content:center}.card-header-icon{align-items:center;cursor:pointer;display:flex;justify-content:center;padding:.75rem}.card-image{display:block;position:relative}.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 #dbdbdb;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 #dbdbdb}.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:0 2px 3px rgba(10,10,10,0.1),0 0 0 1px rgba(10,10,10,0.1);padding-bottom:.5rem;padding-top:.5rem}.dropdown-item{color:#4a4a4a;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:left;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:#dbdbdb;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}}.list{background-color:#fff;border-radius:4px;box-shadow:0 2px 3px rgba(10,10,10,0.1),0 0 0 1px rgba(10,10,10,0.1)}.list-item{display:block;padding:0.5em 1em}.list-item:not(a){color:#222}.list-item:first-child{border-top-left-radius:4px;border-top-right-radius:4px}.list-item:last-child{border-bottom-left-radius:4px;border-bottom-right-radius:4px}.list-item:not(:last-child){border-bottom:1px solid #dbdbdb}.list-item.is-active{background-color:#2e63b8;color:#fff}a.list-item{background-color:#f5f5f5;cursor:pointer}.media{align-items:flex-start;display:flex;text-align:left}.media .content:not(:last-child){margin-bottom:0.75rem}.media .media{border-top:1px solid rgba(219,219,219,0.5);display:flex;padding-top:0.75rem}.media .media .content:not(:last-child),.media .media .control:not(:last-child){margin-bottom:0.5rem}.media .media .media{padding-top:0.5rem}.media .media .media+.media{margin-top:0.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:left}@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;color:#4d4d4d}.message.is-black{background-color:#fafafa}.message.is-black .message-header{background-color:#0a0a0a;color:#fff}.message.is-black .message-body{border-color:#0a0a0a;color:#090909}.message.is-light{background-color:#fafafa}.message.is-light .message-header{background-color:#f5f5f5;color:#363636}.message.is-light .message-body{border-color:#f5f5f5;color:#505050}.message.is-dark,.content kbd.message{background-color:#fafafa}.message.is-dark .message-header,.content kbd.message .message-header{background-color:#363636;color:#f5f5f5}.message.is-dark .message-body,.content kbd.message .message-body{border-color:#363636;color:#2a2a2a}.message.is-primary,.docstring>section>a.message.docs-sourcelink{background-color:#f6fbfd}.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:#1f556a}.message.is-link{background-color:#f7f9fd}.message.is-link .message-header{background-color:#2e63b8;color:#fff}.message.is-link .message-body{border-color:#2e63b8;color:#264981}.message.is-info{background-color:#f6fbfe}.message.is-info .message-header{background-color:#209cee;color:#fff}.message.is-info .message-body{border-color:#209cee;color:#12537d}.message.is-success{background-color:#f6fdf9}.message.is-success .message-header{background-color:#22c35b;color:#fff}.message.is-success .message-body{border-color:#22c35b;color:#0f361d}.message.is-warning{background-color:#fffdf5}.message.is-warning .message-header{background-color:#ffdd57;color:rgba(0,0,0,0.7)}.message.is-warning .message-body{border-color:#ffdd57;color:#3c3108}.message.is-danger{background-color:#fff5f5}.message.is-danger .message-header{background-color:#da0b00;color:#fff}.message.is-danger .message-body{border-color:#da0b00;color:#9b0c04}.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:0.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),print{.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:0.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:#363636}.navbar.is-light .navbar-brand>.navbar-item,.navbar.is-light .navbar-brand .navbar-link{color:#363636}.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:#363636}.navbar.is-light .navbar-brand .navbar-link::after{border-color:#363636}.navbar.is-light .navbar-burger{color:#363636}@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:#363636}.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:#363636}.navbar.is-light .navbar-start .navbar-link::after,.navbar.is-light .navbar-end .navbar-link::after{border-color:#363636}.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:#363636}.navbar.is-light .navbar-dropdown a.navbar-item.is-active{background-color:#f5f5f5;color:#363636}}.navbar.is-dark,.content kbd.navbar{background-color:#363636;color:#f5f5f5}.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:#f5f5f5}.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:#f5f5f5}.navbar.is-dark .navbar-brand .navbar-link::after,.content kbd.navbar .navbar-brand .navbar-link::after{border-color:#f5f5f5}.navbar.is-dark .navbar-burger,.content kbd.navbar .navbar-burger{color:#f5f5f5}@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:#f5f5f5}.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:#f5f5f5}.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:#f5f5f5}.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:#f5f5f5}.navbar.is-dark .navbar-dropdown a.navbar-item.is-active,.content kbd.navbar .navbar-dropdown a.navbar-item.is-active{background-color:#363636;color:#f5f5f5}}.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:#209cee;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:#1190e3;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:#1190e3;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:#1190e3;color:#fff}.navbar.is-info .navbar-dropdown a.navbar-item.is-active{background-color:#209cee;color:#fff}}.navbar.is-success{background-color:#22c35b;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:#1ead51;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:#1ead51;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:#1ead51;color:#fff}.navbar.is-success .navbar-dropdown a.navbar-item.is-active{background-color:#22c35b;color:#fff}}.navbar.is-warning{background-color:#ffdd57;color:rgba(0,0,0,0.7)}.navbar.is-warning .navbar-brand>.navbar-item,.navbar.is-warning .navbar-brand .navbar-link{color:rgba(0,0,0,0.7)}.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:#ffd83e;color:rgba(0,0,0,0.7)}.navbar.is-warning .navbar-brand .navbar-link::after{border-color:rgba(0,0,0,0.7)}.navbar.is-warning .navbar-burger{color:rgba(0,0,0,0.7)}@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:rgba(0,0,0,0.7)}.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:#ffd83e;color:rgba(0,0,0,0.7)}.navbar.is-warning .navbar-start .navbar-link::after,.navbar.is-warning .navbar-end .navbar-link::after{border-color:rgba(0,0,0,0.7)}.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:#ffd83e;color:rgba(0,0,0,0.7)}.navbar.is-warning .navbar-dropdown a.navbar-item.is-active{background-color:#ffdd57;color:rgba(0,0,0,0.7)}}.navbar.is-danger{background-color:#da0b00;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:#c10a00;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:#c10a00;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:#c10a00;color:#fff}.navbar.is-danger .navbar-dropdown a.navbar-item.is-active{background-color:#da0b00;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:#4a4a4a;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:#4a4a4a;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{display:block;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{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:290486px}.pagination.is-rounded .pagination-link,#documenter .docs-sidebar form.docs-search>input.pagination .pagination-link{border-radius:290486px}.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:#363636;min-width:2.25em}.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-next[disabled],.pagination-link[disabled]{background-color:#dbdbdb;border-color:#dbdbdb;box-shadow:none;color:#6b6b6b;opacity:0.5}.pagination-previous,.pagination-next{padding-left:0.75em;padding-right:0.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}@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{order:2}.pagination-next{order:3}.pagination{justify-content:space-between}.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{font-size:1rem}.panel:not(:last-child){margin-bottom:1.5rem}.panel-heading,.panel-tabs,.panel-block{border-bottom:1px solid #dbdbdb;border-left:1px solid #dbdbdb;border-right:1px solid #dbdbdb}.panel-heading:first-child,.panel-tabs:first-child,.panel-block:first-child{border-top:1px solid #dbdbdb}.panel-heading{background-color:#f5f5f5;border-radius:4px 4px 0 0;color:#222;font-size:1.25em;font-weight:300;line-height:1.25;padding:0.5em 0.75em}.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:0.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}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:0.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:0.5em}.tabs .icon:last-child{margin-left:0.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-radius:4px 0 0 4px}.tabs.is-toggle li:last-child a{border-radius:0 4px 4px 0}.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:290486px;border-top-left-radius:290486px;padding-left:1.25em}.tabs.is-toggle.is-toggle-rounded li:last-child a{border-bottom-right-radius:290486px;border-top-right-radius:290486px;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}.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.3333333333%}.columns.is-mobile>.column.is-offset-1{margin-left:8.3333333333%}.columns.is-mobile>.column.is-2{flex:none;width:16.6666666667%}.columns.is-mobile>.column.is-offset-2{margin-left:16.6666666667%}.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.3333333333%}.columns.is-mobile>.column.is-offset-4{margin-left:33.3333333333%}.columns.is-mobile>.column.is-5{flex:none;width:41.6666666667%}.columns.is-mobile>.column.is-offset-5{margin-left:41.6666666667%}.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.3333333333%}.columns.is-mobile>.column.is-offset-7{margin-left:58.3333333333%}.columns.is-mobile>.column.is-8{flex:none;width:66.6666666667%}.columns.is-mobile>.column.is-offset-8{margin-left:66.6666666667%}.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.3333333333%}.columns.is-mobile>.column.is-offset-10{margin-left:83.3333333333%}.columns.is-mobile>.column.is-11{flex:none;width:91.6666666667%}.columns.is-mobile>.column.is-offset-11{margin-left:91.6666666667%}.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}.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.3333333333%}.column.is-offset-1-mobile{margin-left:8.3333333333%}.column.is-2-mobile{flex:none;width:16.6666666667%}.column.is-offset-2-mobile{margin-left:16.6666666667%}.column.is-3-mobile{flex:none;width:25%}.column.is-offset-3-mobile{margin-left:25%}.column.is-4-mobile{flex:none;width:33.3333333333%}.column.is-offset-4-mobile{margin-left:33.3333333333%}.column.is-5-mobile{flex:none;width:41.6666666667%}.column.is-offset-5-mobile{margin-left:41.6666666667%}.column.is-6-mobile{flex:none;width:50%}.column.is-offset-6-mobile{margin-left:50%}.column.is-7-mobile{flex:none;width:58.3333333333%}.column.is-offset-7-mobile{margin-left:58.3333333333%}.column.is-8-mobile{flex:none;width:66.6666666667%}.column.is-offset-8-mobile{margin-left:66.6666666667%}.column.is-9-mobile{flex:none;width:75%}.column.is-offset-9-mobile{margin-left:75%}.column.is-10-mobile{flex:none;width:83.3333333333%}.column.is-offset-10-mobile{margin-left:83.3333333333%}.column.is-11-mobile{flex:none;width:91.6666666667%}.column.is-offset-11-mobile{margin-left:91.6666666667%}.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}.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.3333333333%}.column.is-offset-1,.column.is-offset-1-tablet{margin-left:8.3333333333%}.column.is-2,.column.is-2-tablet{flex:none;width:16.6666666667%}.column.is-offset-2,.column.is-offset-2-tablet{margin-left:16.6666666667%}.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.3333333333%}.column.is-offset-4,.column.is-offset-4-tablet{margin-left:33.3333333333%}.column.is-5,.column.is-5-tablet{flex:none;width:41.6666666667%}.column.is-offset-5,.column.is-offset-5-tablet{margin-left:41.6666666667%}.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.3333333333%}.column.is-offset-7,.column.is-offset-7-tablet{margin-left:58.3333333333%}.column.is-8,.column.is-8-tablet{flex:none;width:66.6666666667%}.column.is-offset-8,.column.is-offset-8-tablet{margin-left:66.6666666667%}.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.3333333333%}.column.is-offset-10,.column.is-offset-10-tablet{margin-left:83.3333333333%}.column.is-11,.column.is-11-tablet{flex:none;width:91.6666666667%}.column.is-offset-11,.column.is-offset-11-tablet{margin-left:91.6666666667%}.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}.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.3333333333%}.column.is-offset-1-touch{margin-left:8.3333333333%}.column.is-2-touch{flex:none;width:16.6666666667%}.column.is-offset-2-touch{margin-left:16.6666666667%}.column.is-3-touch{flex:none;width:25%}.column.is-offset-3-touch{margin-left:25%}.column.is-4-touch{flex:none;width:33.3333333333%}.column.is-offset-4-touch{margin-left:33.3333333333%}.column.is-5-touch{flex:none;width:41.6666666667%}.column.is-offset-5-touch{margin-left:41.6666666667%}.column.is-6-touch{flex:none;width:50%}.column.is-offset-6-touch{margin-left:50%}.column.is-7-touch{flex:none;width:58.3333333333%}.column.is-offset-7-touch{margin-left:58.3333333333%}.column.is-8-touch{flex:none;width:66.6666666667%}.column.is-offset-8-touch{margin-left:66.6666666667%}.column.is-9-touch{flex:none;width:75%}.column.is-offset-9-touch{margin-left:75%}.column.is-10-touch{flex:none;width:83.3333333333%}.column.is-offset-10-touch{margin-left:83.3333333333%}.column.is-11-touch{flex:none;width:91.6666666667%}.column.is-offset-11-touch{margin-left:91.6666666667%}.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}.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.3333333333%}.column.is-offset-1-desktop{margin-left:8.3333333333%}.column.is-2-desktop{flex:none;width:16.6666666667%}.column.is-offset-2-desktop{margin-left:16.6666666667%}.column.is-3-desktop{flex:none;width:25%}.column.is-offset-3-desktop{margin-left:25%}.column.is-4-desktop{flex:none;width:33.3333333333%}.column.is-offset-4-desktop{margin-left:33.3333333333%}.column.is-5-desktop{flex:none;width:41.6666666667%}.column.is-offset-5-desktop{margin-left:41.6666666667%}.column.is-6-desktop{flex:none;width:50%}.column.is-offset-6-desktop{margin-left:50%}.column.is-7-desktop{flex:none;width:58.3333333333%}.column.is-offset-7-desktop{margin-left:58.3333333333%}.column.is-8-desktop{flex:none;width:66.6666666667%}.column.is-offset-8-desktop{margin-left:66.6666666667%}.column.is-9-desktop{flex:none;width:75%}.column.is-offset-9-desktop{margin-left:75%}.column.is-10-desktop{flex:none;width:83.3333333333%}.column.is-offset-10-desktop{margin-left:83.3333333333%}.column.is-11-desktop{flex:none;width:91.6666666667%}.column.is-offset-11-desktop{margin-left:91.6666666667%}.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}.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.3333333333%}.column.is-offset-1-widescreen{margin-left:8.3333333333%}.column.is-2-widescreen{flex:none;width:16.6666666667%}.column.is-offset-2-widescreen{margin-left:16.6666666667%}.column.is-3-widescreen{flex:none;width:25%}.column.is-offset-3-widescreen{margin-left:25%}.column.is-4-widescreen{flex:none;width:33.3333333333%}.column.is-offset-4-widescreen{margin-left:33.3333333333%}.column.is-5-widescreen{flex:none;width:41.6666666667%}.column.is-offset-5-widescreen{margin-left:41.6666666667%}.column.is-6-widescreen{flex:none;width:50%}.column.is-offset-6-widescreen{margin-left:50%}.column.is-7-widescreen{flex:none;width:58.3333333333%}.column.is-offset-7-widescreen{margin-left:58.3333333333%}.column.is-8-widescreen{flex:none;width:66.6666666667%}.column.is-offset-8-widescreen{margin-left:66.6666666667%}.column.is-9-widescreen{flex:none;width:75%}.column.is-offset-9-widescreen{margin-left:75%}.column.is-10-widescreen{flex:none;width:83.3333333333%}.column.is-offset-10-widescreen{margin-left:83.3333333333%}.column.is-11-widescreen{flex:none;width:91.6666666667%}.column.is-offset-11-widescreen{margin-left:91.6666666667%}.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}.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.3333333333%}.column.is-offset-1-fullhd{margin-left:8.3333333333%}.column.is-2-fullhd{flex:none;width:16.6666666667%}.column.is-offset-2-fullhd{margin-left:16.6666666667%}.column.is-3-fullhd{flex:none;width:25%}.column.is-offset-3-fullhd{margin-left:25%}.column.is-4-fullhd{flex:none;width:33.3333333333%}.column.is-offset-4-fullhd{margin-left:33.3333333333%}.column.is-5-fullhd{flex:none;width:41.6666666667%}.column.is-offset-5-fullhd{margin-left:41.6666666667%}.column.is-6-fullhd{flex:none;width:50%}.column.is-offset-6-fullhd{margin-left:50%}.column.is-7-fullhd{flex:none;width:58.3333333333%}.column.is-offset-7-fullhd{margin-left:58.3333333333%}.column.is-8-fullhd{flex:none;width:66.6666666667%}.column.is-offset-8-fullhd{margin-left:66.6666666667%}.column.is-9-fullhd{flex:none;width:75%}.column.is-offset-9-fullhd{margin-left:75%}.column.is-10-fullhd{flex:none;width:83.3333333333%}.column.is-offset-10-fullhd{margin-left:83.3333333333%}.column.is-11-fullhd{flex:none;width:91.6666666667%}.column.is-offset-11-fullhd{margin-left:91.6666666667%}.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.3333333333%}.tile.is-2{flex:none;width:16.6666666667%}.tile.is-3{flex:none;width:25%}.tile.is-4{flex:none;width:33.3333333333%}.tile.is-5{flex:none;width:41.6666666667%}.tile.is-6{flex:none;width:50%}.tile.is-7{flex:none;width:58.3333333333%}.tile.is-8{flex:none;width:66.6666666667%}.tile.is-9{flex:none;width:75%}.tile.is-10{flex:none;width:83.3333333333%}.tile.is-11{flex:none;width:91.6666666667%}.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{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{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:#363636}.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:#363636}.hero.is-light .subtitle{color:rgba(54,54,54,0.9)}.hero.is-light .subtitle a:not(.button),.hero.is-light .subtitle strong{color:#363636}@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(54,54,54,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:#363636}.hero.is-light .tabs a{color:#363636;opacity:0.9}.hero.is-light .tabs a:hover{opacity:1}.hero.is-light .tabs li.is-active a{opacity:1}.hero.is-light .tabs.is-boxed a,.hero.is-light .tabs.is-toggle a{color:#363636}.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:#363636;border-color:#363636;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:#f5f5f5}.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:#f5f5f5}.hero.is-dark .subtitle,.content kbd.hero .subtitle{color:rgba(245,245,245,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:#f5f5f5}@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(245,245,245,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:#f5f5f5}.hero.is-dark .tabs a,.content kbd.hero .tabs a{color:#f5f5f5;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{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:#f5f5f5}.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:#f5f5f5;border-color:#f5f5f5;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{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{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:#209cee;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:#209cee}}.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:#1190e3;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{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:#209cee}.hero.is-info.is-bold{background-image:linear-gradient(141deg, #05a6d6 0%, #209cee 71%, #3287f5 100%)}@media screen and (max-width: 768px){.hero.is-info.is-bold .navbar-menu{background-image:linear-gradient(141deg, #05a6d6 0%, #209cee 71%, #3287f5 100%)}}.hero.is-success{background-color:#22c35b;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:#22c35b}}.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:#1ead51;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{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:#22c35b}.hero.is-success.is-bold{background-image:linear-gradient(141deg, #12a02c 0%, #22c35b 71%, #1fdf83 100%)}@media screen and (max-width: 768px){.hero.is-success.is-bold .navbar-menu{background-image:linear-gradient(141deg, #12a02c 0%, #22c35b 71%, #1fdf83 100%)}}.hero.is-warning{background-color:#ffdd57;color:rgba(0,0,0,0.7)}.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:rgba(0,0,0,0.7)}.hero.is-warning .subtitle{color:rgba(0,0,0,0.9)}.hero.is-warning .subtitle a:not(.button),.hero.is-warning .subtitle strong{color:rgba(0,0,0,0.7)}@media screen and (max-width: 1055px){.hero.is-warning .navbar-menu{background-color:#ffdd57}}.hero.is-warning .navbar-item,.hero.is-warning .navbar-link{color:rgba(0,0,0,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:#ffd83e;color:rgba(0,0,0,0.7)}.hero.is-warning .tabs a{color:rgba(0,0,0,0.7);opacity:0.9}.hero.is-warning .tabs a:hover{opacity:1}.hero.is-warning .tabs li.is-active a{opacity:1}.hero.is-warning .tabs.is-boxed a,.hero.is-warning .tabs.is-toggle a{color:rgba(0,0,0,0.7)}.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:rgba(0,0,0,0.7);border-color:rgba(0,0,0,0.7);color:#ffdd57}.hero.is-warning.is-bold{background-image:linear-gradient(141deg, #ffae24 0%, #ffdd57 71%, #fffa71 100%)}@media screen and (max-width: 768px){.hero.is-warning.is-bold .navbar-menu{background-image:linear-gradient(141deg, #ffae24 0%, #ffdd57 71%, #fffa71 100%)}}.hero.is-danger{background-color:#da0b00;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:#da0b00}}.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:#c10a00;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{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:#da0b00}.hero.is-danger.is-bold{background-image:linear-gradient(141deg, #a70013 0%, #da0b00 71%, #f43500 100%)}@media screen and (max-width: 768px){.hero.is-danger.is-bold .navbar-menu{background-image:linear-gradient(141deg, #a70013 0%, #da0b00 71%, #f43500 100%)}}.hero.is-small .hero-body,#documenter .docs-sidebar form.docs-search>input.hero .hero-body{padding-bottom:1.5rem;padding-top:1.5rem}@media screen and (min-width: 769px),print{.hero.is-medium .hero-body{padding-bottom:9rem;padding-top:9rem}}@media screen and (min-width: 769px),print{.hero.is-large .hero-body{padding-bottom:18rem;padding-top:18rem}}.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}.section{padding:3rem 1.5rem}@media screen and (min-width: 1056px){.section.is-medium{padding:9rem 1.5rem}.section.is-large{padding:18rem 1.5rem}}.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 5 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 5 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:#b5b5b5;border-style:solid;border-width:1px;border-color:#363636;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:#b5b5b5;border-color:#363636}.admonition.is-default>.admonition-header{background-color:#363636;color:#fff}.admonition.is-default>.admonition-body{color:#fff}.admonition.is-info{background-color:#def0fc;border-color:#209cee}.admonition.is-info>.admonition-header{background-color:#209cee;color:#fff}.admonition.is-info>.admonition-body{color:rgba(0,0,0,0.7)}.admonition.is-success{background-color:#bdf4d1;border-color:#22c35b}.admonition.is-success>.admonition-header{background-color:#22c35b;color:#fff}.admonition.is-success>.admonition-body{color:rgba(0,0,0,0.7)}.admonition.is-warning{background-color:#fff3c5;border-color:#ffdd57}.admonition.is-warning>.admonition-header{background-color:#ffdd57;color:rgba(0,0,0,0.7)}.admonition.is-warning>.admonition-body{color:rgba(0,0,0,0.7)}.admonition.is-danger{background-color:#ffaba7;border-color:#da0b00}.admonition.is-danger>.admonition-header{background-color:#da0b00;color:#fff}.admonition.is-danger>.admonition-body{color:rgba(0,0,0,0.7)}.admonition.is-compat{background-color:#bdeff5;border-color:#1db5c9}.admonition.is-compat>.admonition-header{background-color:#1db5c9;color:#fff}.admonition.is-compat>.admonition-body{color:rgba(0,0,0,0.7)}.admonition-header{color:#fff;background-color:#363636;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 5 Free";font-weight:900;margin-right:.75rem;content:"\f06a"}.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:1px solid #dbdbdb;box-shadow:2px 2px 3px rgba(10,10,10,0.1);max-width:100%}.docstring>header{display:flex;flex-grow:1;align-items:stretch;padding:0.5rem .75rem;background-color:#f5f5f5;box-shadow:0 1px 2px rgba(10,10,10,0.1);box-shadow:none;border-bottom:1px solid #dbdbdb}.docstring>header code{background-color:transparent}.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:#ffaba7;color:rgba(0,0,0,0.7);border-bottom:3px solid #da0b00;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:1px solid #dbdbdb}.content code{font-weight:inherit}.content a code{color:#2e63b8}.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}#documenter .docs-main header.docs-navbar .docs-right{display:flex;white-space:nowrap}#documenter .docs-main header.docs-navbar .docs-right .docs-icon,#documenter .docs-main header.docs-navbar .docs-right .docs-label,#documenter .docs-main header.docs-navbar .docs-right .docs-sidebar-button{display:inline-block}#documenter .docs-main header.docs-navbar .docs-right .docs-label{padding:0;margin-left:0.3em}#documenter .docs-main header.docs-navbar .docs-right .docs-settings-button{margin:auto 0 auto 1rem}#documenter .docs-main header.docs-navbar .docs-right .docs-sidebar-button{font-size:1.5rem;margin:auto 0 auto 1rem}#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 5 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}@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}}#documenter .docs-main #documenter-search-info{margin-bottom:1rem}#documenter .docs-main #documenter-search-results{list-style-type:circle;list-style-position:outside}#documenter .docs-main #documenter-search-results li{margin-left:2rem}#documenter .docs-main #documenter-search-results .docs-highlight{background-color:yellow}.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}code.hljs{padding:3px 5px}.hljs{background:#F0F0F0;color:#444}.hljs-comment{color:#888888}.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:#BC6060}.hljs-literal{color:#78A960}.hljs-built_in,.hljs-bullet,.hljs-code,.hljs-addition{color:#397300}.hljs-meta{color:#1f7199}.hljs-meta .hljs-string{color:#4d99bf}.hljs-emphasis{font-style:italic}.hljs-strong{font-weight:bold} diff --git a/previews/PR360/assets/themeswap.js b/previews/PR360/assets/themeswap.js new file mode 100644 index 000000000..c58e993e3 --- /dev/null +++ b/previews/PR360/assets/themeswap.js @@ -0,0 +1,66 @@ +// Small function to quickly swap out themes. Gets put into the tag.. +function set_theme_from_local_storage() { + // Intialize 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 browser supports user color preference + var darkPreference = false; + // Check if the users preference is for dark color scheme + if(window.matchMedia('(prefers-color-scheme: dark)').matches === true) { + darkPreference = 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 darkTheme = 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. + var isprimary = (ss.ownerNode.getAttribute("data-theme-primary") !== null); + // Check if the theme is primary dark theme + var isDarkTheme = (ss.ownerNode.getAttribute("data-theme-primary-dark") !== null); + // If ss is for dark theme then set the value of darkTheme to the name of the theme + if(isDarkTheme) darkTheme = 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); + } + 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; + // and (2) disable all the other theme stylesheets + disabled.forEach(function(ss){ + ss.disabled = true; + }); + } + else if(darkTheme !== null && darkPreference === true) { + // If we did find an active theme, we'll (1) add the theme--$(theme) class to + document.getElementsByTagName('html')[0].className = "theme--" + darkTheme; + // and (2) disable all the other theme stylesheets + disabled.forEach(function(ss){ + if (ss.ownerNode.getAttribute("data-theme-name") !== darkTheme) { + ss.disabled = true; + } + }); + } +} +set_theme_from_local_storage(); diff --git a/previews/PR360/assets/unicode.png b/previews/PR360/assets/unicode.png new file mode 100644 index 000000000..6575482b5 Binary files /dev/null and b/previews/PR360/assets/unicode.png differ diff --git a/previews/PR360/assets/warner.js b/previews/PR360/assets/warner.js new file mode 100644 index 000000000..5531c8851 --- /dev/null +++ b/previews/PR360/assets/warner.js @@ -0,0 +1,49 @@ +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/PR360/code_base_developer_guide/developer/index.html b/previews/PR360/code_base_developer_guide/developer/index.html new file mode 100644 index 000000000..3be936a1e --- /dev/null +++ b/previews/PR360/code_base_developer_guide/developer/index.html @@ -0,0 +1,2 @@ + +Developer Guide · PowerSimulationsDynamics.jl
    diff --git a/previews/PR360/component_models/avr/index.html b/previews/PR360/component_models/avr/index.html new file mode 100644 index 000000000..606db9c85 --- /dev/null +++ b/previews/PR360/component_models/avr/index.html @@ -0,0 +1,75 @@ + +AVR · PowerSimulationsDynamics.jl

    Automatic Voltage Regulators (AVR)

    AVR are used to determine the voltage in the field winding $v_f$ (or $V_f$) in the model.

    Fixed AVR [AVRFixed]

    This is a simple model that set the field voltage to be equal to a desired constant value $v_f = v_{\text{fix}}$.

    Simple AVR [AVRSimple]

    This depicts the most basic AVR, on which the field voltage is an integrator over the difference of the measured voltage and a reference:

    \[\begin{align} +\dot{v}_f = K_v(v_{\text{ref}} - v_h) \tag{1a} +\end{align}\]

    AVR Type I [AVRTypeI]

    This AVR is a simplified version of the IEEE DC1 AVR model:

    \[\begin{align} +\dot{v}_f &= -\frac{1}{T_e} \left[ V_f(K_e + S_e(v_f))-v_{r1} \right] \tag{2a} \\ +\dot{v}_{r1} &= \frac{1}{T_a} \left[ K_a\left(v_{\text{ref}} - v_m - v_{r2} - \frac{K_f}{T_f}v_f\right) - v_{r1} \right] \tag{2b} \\ +\dot{v}_{r2} &= -\frac{1}{T_f} \left[ \frac{K_f}{T_f}v_f + v_{r2} \right] \tag{2c} \\ +\dot{v}_m &= \frac{1}{T_r} (v_h - v_m) \tag{2d} +\end{align}\]

    with the ceiling function:

    \[\begin{align*} +S_e(v_f) = A_e \exp(B_e|v_f|) +\end{align*}\]

    AVR Type II [AVRTypeII]

    This model represents a static exciter with higher gains and faster response than the Type I:

    \[\begin{align} +\dot{v}_f &= -\frac{1}{T_e} \left[ V_f(1 + S_e(v_f))-v_{r} \right] \tag{3a} \\ +\dot{v}_{r1} &= \frac{1}{T_1} \left[ K_0\left(1 - \frac{T_2}{T_1} \right)(v_{\text{ref}} - v_m) - v_{r1} \right] \tag{3b} \\ +\dot{v}_{r2} &= \frac{1}{K_0 T_3} \left[ \left( 1 - \frac{T_4}{T_3} \right) \left( v_{r1} + K_0\frac{T_2}{T_1}(v_{\text{ref}} - v_m)\right) - K_0 v_{r2} \right] \tag{3c} \\ +\dot{v}_m &= \frac{1}{T_r} (v_h - v_m) \tag{3d} +\end{align}\]

    with

    \[\begin{align*} +v_r &= K_0v_{r2} + \frac{T_4}{T_3} \left( v_{r1} + K_0\frac{T_2}{T_1}(v_{\text{ref}} - v_m)\right) \\ +S_e(v_f) &= A_e \exp(B_e|v_f|) +\end{align*}\]

    Excitation System AC1A [ESAC1A]

    The model represents the 5-states IEEE Type AC1A Excitation System Model:

    \[\begin{align} +\dot{V}_m &= \frac{1}{T_r} (V_{h} - V_m) \tag{4a} \\ +\dot{V}_{r1} &= \frac{1}{T_b} \left(V_{in} \left(1 - \frac{T_c}{T_b}\right) - V_{r1}\right) \tag{4b} \\ +\dot{V}_{r2} &= \frac{1}{T_a} (K_a V_{out} - V_{r2}) \tag{4c} \\ +\dot{V}_e &= \frac{1}{T_e} (V_r - V_{FE}) \tag{4d} \\ +\dot{V}_{r3} &= \frac{1}{T_f} \left( - \frac{K_f}{T_f}V_{FE} - V_{r3} \right) \tag{4e} \\ +\end{align}\]

    with

    \[\begin{align*} +I_N &= \frac{K_c}{V_e} X_{ad}I_{fd} \\ +V_{FE} &= K_d X_{ad}I_{fd} + K_e V_e + S_e V_e \\ +S_e &= B\frac{(V_e-A)^2}{V_e} \\ +V_{F1} &= V_{r3} + \frac{K_f}{T_f} V_{FE} \\ +V_{in} &= V_{ref} - V_m - V_{F1} \\ +V_{out} &= V_{r1} + \frac{T_c}{T_b} V_{in} \\ +V_f &= V_e f(I_N) \\ +f(I_N) &= \left\{\begin{array}{cl} + 1 & \text{ if }I_N \le 0 \\ + 1 - 0.577 I_N & \text{ if } 0 < I_N \le 0.433 \\ + \sqrt{0.75 - I_N^2} & \text{ if } 0.433 < I_N \le 0.75 \\ + 1.732(1-I_N) & \text{ if } 0.75 < I_N \le 1 \\ + 0 & \text{ if } I_N > 1 \end{array} \right. +\end{align*}\]

    on which $X_{ad}I_{fd}$ is the field current coming from the generator and $V_{h}$ is the terminal voltage, and $A,B$ are the saturation coefficients computed using the $E_1, E_2, S_e(E_1), S_e(E_2)$ data.

    Simplified Excitation System [SEXS]

    The model for the 2 states excitation system SEXS:

    \[\begin{align} +\dot{V}_f &= \frac{1}{T_e} (V_{LL} - V_f) \tag{5a} \\ +\dot{V}_r &= \frac{1}{T_b} \left[\left(1 - \frac{T_a}{T_b}\right) V_{in} - V_r \right] \tag{5b} +\end{align}\]

    with

    \[\begin{align*} +V_{in} &= V_{ref} + V_s - V_h \\ +V_{LL} &= V_r + \frac{T_a}{T_b}V_{in} \\ +\end{align*}\]

    on which $V_h$ is the terminal voltage and $V_s$ is the PSS output signal.

    Excitation System ST1 [EXST1]

    The model represents the 4-states IEEE Type ST1 Excitation System Model:

    \[\begin{align} +\dot{V}_m &= \frac{1}{T_r} (V_{h} - V_m) \tag{6a} \\ +\dot{V}_{rll} &= \frac{1}{T_b} \left(V_{in} \left(1 - \frac{T_c}{T_b}\right) - V_{rll}\right) \tag{6b} \\ +\dot{V}_{r} &= \frac{1}{T_a} (V_{LL} - V_{r}) \tag{6c} \\ +\dot{V}_{fb} &= \frac{1}{T_f} \left( - \frac{K_f}{T_f}V_{r} - V_{fb} \right) \tag{6d} \\ +\end{align}\]

    with

    \[\begin{align*} +V_{in} &= V_{ref} - V_m - y_{hp} \\ +V_{LL} &= V_{r} + \frac{T_c}{T_b} V_{in} \\ +y_{hp} &= V_{fb} + \frac{K_f}{T_f} V_r \\ +V_f &= V_r \\ +\end{align*}\]

    on which $V_h$ is the terminal voltage.

    Excitation System EXAC1 [EXAC1]

    The model represents the 5-states IEEE Type EXAC1 Excitation System Model:

    \[\begin{align} +\dot{V}_m &= \frac{1}{T_r} (V_{h} - V_m) \tag{7a} \\ +\dot{V}_{r1} &= \frac{1}{T_b} \left(V_{in} \left(1 - \frac{T_c}{T_b}\right) - V_{r1}\right) \tag{7b} \\ +\dot{V}_{r2} &= \frac{1}{T_a} (K_a V_{out} - V_{r2}) \tag{7c} \\ +\dot{V}_e &= \frac{1}{T_e} (V_r - V_{FE}) \tag{7d} \\ +\dot{V}_{r3} &= \frac{1}{T_f} \left( - \frac{K_f}{T_f}V_{FE} - V_{r3} \right) \tag{7e} \\ +\end{align}\]

    with

    \[\begin{align*} +I_N &= \frac{K_c}{V_e} X_{ad}I_{fd} \\ +V_{FE} &= K_d X_{ad}I_{fd} + K_e V_e + S_e V_e \\ +S_e &= B\frac{(V_e-A)^2}{V_e} \\ +V_{F1} &= V_{r3} + \frac{K_f}{T_f} V_{FE} \\ +V_{in} &= V_{ref} - V_m - V_{F1} \\ +V_{out} &= V_{r1} + \frac{T_c}{T_b} V_{in} \\ +V_f &= V_e f(I_N) \\ +f(I_N) &= \left\{\begin{array}{cl} + 1 & \text{ if }I_N \le 0 \\ + 1 - 0.577 I_N & \text{ if } 0 < I_N \le 0.433 \\ + \sqrt{0.75 - I_N^2} & \text{ if } 0.433 < I_N \le 0.75 \\ + 1.732(1-I_N) & \text{ if } 0.75 < I_N \le 1 \\ + 0 & \text{ if } I_N > 1 \end{array} \right. +\end{align*}\]

    on which $X_{ad}I_{fd}$ is the field current coming from the generator and $V_{h}$ is the terminal voltage, and $A,B$ are the saturation coefficients computed using the $E_1, E_2, S_e(E_1), S_e(E_2)$ data.

    diff --git a/previews/PR360/component_models/converter/index.html b/previews/PR360/component_models/converter/index.html new file mode 100644 index 000000000..cc231dbee --- /dev/null +++ b/previews/PR360/component_models/converter/index.html @@ -0,0 +1,25 @@ + +Converter · PowerSimulationsDynamics.jl

    Converter

    This component can be used to model the dynamics of the switching process.

    Average Model [AverageConverter]

    The average model outputs the desired reference signal since:

    \[\begin{align} +v_{d}^{\text{cv}} \approx m_{d} v_{\text{dc}} \approx \frac{v_{d}^{\text{ref-signal}}}{v_{\text{dc}}} v_{\text{dc}} \approx v_{d}^{\text{ref-signal}} \tag{1a} \\ +v_{q}^{\text{cv}} \approx m_{q} v_{\text{dc}} \approx \frac{v_{q}^{\text{ref-signal}}}{v_{\text{dc}}} v_{\text{dc}} \approx v_{q}^{\text{ref-signal}} \tag{1b} +\end{align}\]

    where $m_{dq}$ is the modulation signal, and $v_{dq}^{\text{ref-signal}}$ is the voltage reference signal from the inner loop control.

    Generic Renewable Converter Type A ```[RenewableEnergyConverterTypeA]

    This block represents the REGCA model. The equations (without the limiters) are:

    \[\begin{align} + \dot{I}_p &= \frac{1}{T_g} (I_\text{pcmd} - I_p) \tag{2a} \\ + \dot{I}_q &= \frac{1}{T_g} (I_\text{qcmd} - I_q) \tag{2b} \\ + \dot{V}_\text{meas} &= \frac{1}{T_{fltr}} (V_t - V_\text{meas} \tag{2c}) +\end{align}\]

    on which $I_\text{pcmd}$ and $I_\text{qcmd}$ are the current commands from the inner control and $V_t$ is the bus voltage magnitude. The additional terms and output current are computed as:

    \[\begin{align} + I_q^\text{cv} &= -I_q - I_\text{q,extra} \tag{2d} \\ + I_\text{q,extra} &= \max(K_{hv} (V_t - V_\text{olim})) \tag{2e} \\ + I_p^\text{cv} &= G_{lv} I_p \tag{2f} +\end{align}\]

    on which $G_{lv}$ is the gain used for Low Voltage Active Current Management and $I_\text{q,extra}$ is the additional current for High Voltage Reactive Current Management.

    It is important to note that both current commands coming from the inner control were obtained by dividing the active (or reactive) power by the magnitude voltage instead of using the correct phasor formula $I = (S/V)^*$. For that purpose, a correction factor must be applied to obtain the correct output currents in the network reference frame:

    \[\begin{align*} + I_r + jI_i &= (I_p + jI_q) \cdot V_t \cdot \frac{1}{V_r + jV_i} \\ + &= (I_p + jI_q) \cdot \frac{V_t}{V_t e^{j\theta}} \\ + &= (I_p + jI_q) \cdot e^{-j\theta} +\end{align*}\]

    This correction factor looks like a reference transformation that must be used to properly inject current into the grid. With that the output current is computed as:

    \[\begin{align} + I_r &= I_p^\text{cv} \cos(\theta) - I_q^\text{cv} \sin(\theta) \tag{2g} \\ + I_i &= I_p^\text{cv} \sin(\theta) + I_q^\text{cv} \cos(\theta) \tag{2h} +\end{align}\]

    This current source is usually modeled as a Norton equivalent using a parallel impedance with values $R_{sorce}$ and $X_{sorce}$ provided in the .raw file. If an RL filter is used, a Voltage Source behind that RL filter (i.e. the converter output voltage) can be computed as:

    \[\begin{align*} + Z_f &= r_f + jl_f \\ + Z_{sorce} &= R_{sorce} + jX_{sorce} \\ + I_{cv} &= I_r + jI_i \\ + v_r^\text{cv} + jv_i^\text{cv} &= \frac{I_{cv} + \frac{v^\text{grid}}{Z_f}}{\frac{1}{Z_{sorce}} + \frac{1}{Z_f}} \tag{2i} +\end{align*}\]

    diff --git a/previews/PR360/component_models/dc_source/index.html b/previews/PR360/component_models/dc_source/index.html new file mode 100644 index 000000000..b2626c6e7 --- /dev/null +++ b/previews/PR360/component_models/dc_source/index.html @@ -0,0 +1,2 @@ + +DC Sources · PowerSimulationsDynamics.jl

    DC Source

    This component can be used to model the dynamics of the DC side of the converter.

    Fixed DC Source [FixedDCSource]

    This is a model that set the DC voltage to a fixed value $v_{\text{dc}} = v_{\text{dc}}^{\text{fix}}$.

    diff --git a/previews/PR360/component_models/filters/index.html b/previews/PR360/component_models/filters/index.html new file mode 100644 index 000000000..7c5f6aeda --- /dev/null +++ b/previews/PR360/component_models/filters/index.html @@ -0,0 +1,13 @@ + +Filter · PowerSimulationsDynamics.jl

    Filters

    LCL Filter [LCLFilter]

    A standard LCL filter is proposed to connect the output of the converter to the grid. In this case, $v_r$ and $v_i$ are voltages in the capacitor, while $v_r^{\text{grid}}$ and $v_i^{\text{grid}}$ represent the voltage at the bus. The L filter after the capacitor can also include a step-up transformer to increase the voltage, that is model as an extra impedance.

    \[\begin{align} + \dot{i}_{r,\text{cv}} &= \frac{\Omega_b}{l_f}\left( v_r^{\text{cv}} - v_r - r_f i_{r,\text{cv}} + \omega_{\text{grid}} l_f i_{i,\text{cv}} \right) \tag{1a} \\ + \dot{i}_{i,\text{cv}} &= \frac{\Omega_b}{l_f}\left( v_i^{\text{cv}} - v_i - r_f i_{i,\text{cv}} - \omega_{\text{grid}} l_f i_{r,\text{cv}} \right) \tag{1b} \\ + \dot{v}_{r} &= \frac{\Omega_b}{c_f}\left( i_r^{\text{cv}} - i_r + \omega_{\text{grid}} c_f v_i \right) \tag{1c} \\ + \dot{v}_{i} &= \frac{\Omega_b}{c_f}\left( i_i^{\text{cv}} - i_i - \omega_{\text{grid}} c_f v_r \right) \tag{1d} \\ + \dot{i}_{r} &= \frac{\Omega_b}{l_g}\left( v_r - v_r^{\text{grid}} - r_g i_{r} + \omega_{\text{grid}} l_g i_{i,\text{cv}} \right) \tag{1e} \\ + \dot{i}_{i} &= \frac{\Omega_b}{l_g}\left( v_i - v_i^{\text{grid}} - r_g i_{i} - \omega_{\text{grid}} l_g i_{r,\text{cv}} \right) \tag{1f} +\end{align}\]

    on which

    \[\begin{align*} +v_r^\text{cv} + jv_i^\text{cv} = (v_d^\text{cv} + jv_q^\text{cv})e^{j\delta\theta_{olc}} +\end{align*}\]

    that comes from the converter model.

    RL Filter [RLFilter]

    The algebraic RL filter is used to connect the output of the converter through a RL series filter using algebraic phasor equations. The equations for the output current are:

    \[\begin{align} + i_r + ji_i &= \frac{(v_r^\text{cv} + j v_i^\text{cv}) - (v_r^\text{grid} + jv_i^\text{grid})}{r_f + jl_f} \tag{2a} +\end{align}\]

    on which $v_r^\text{cv} + jv_i^\text{cv}$ comes from the converter model.

    diff --git a/previews/PR360/component_models/freq_esti/index.html b/previews/PR360/component_models/freq_esti/index.html new file mode 100644 index 000000000..e0f5345b1 --- /dev/null +++ b/previews/PR360/component_models/freq_esti/index.html @@ -0,0 +1,20 @@ + +Frequency Estimators · PowerSimulationsDynamics.jl

    Frequency Estimators

    This component is used to estimate the frequency of the grid based on the voltage at the bus.

    Fixed Frequency [FixedFrequency]

    This is a simple model that set the measured frequency to a desired constant value (i.e. does not measure the frequency) $\omega_{pll} = \omega_{\text{fix}}$ (usually $\omega_{\text{fix}} = 1.0$ p.u.). Used by default when grid-forming inverters do not use frequency estimators.

    Phase-Locked Loop (PLL) for VSM [KauraPLL]

    The following equations present a PLL used to estimate the frequency and PLL angle of the grid. There are two reference frames considered in this inverter. Those are the VSM of the outer-loop control $\theta_{\text{olc}}$ and the PLL one $\theta_{\text{pll}}$. The notation used a $\delta\theta$ refers as the variation of the respective angle $\theta^\text{grid}$ with respect to the grid SRF (instead of the fixed $\alpha$ component of the $\alpha\beta$ transformation):

    \[\begin{align} + +\dot{v}_{d,\text{pll}} &= \omega_{\text{lp}} \left [v_{d,\text{out}} - v_{d,\text{pll}} \right] \tag{1a} \\ +\dot{v}_{q,\text{pll}} &= \omega_{\text{lp}} \left [v_{q,\text{out}} - v_{q,\text{pll}} \right] \tag{1b} \\ +\dot{\varepsilon}_{\text{pll}} &= \tan^{-1}\left(\frac{v_{q,\text{pll}}}{v_{d,\text{pll}}} \right) \tag{1c} \\ +\dot{\theta}_{\text{pll}} &= \Omega_b \delta \omega_{\text{pll}} \tag{1d} +\end{align}\]

    with

    \[\begin{align} +\delta\omega_{\text{pll}} &= 1.0 - \omega_{\text{sys}} + k_{p,\text{pll}} \tan^{-1} \left(\frac{v_{q,\text{pll}}}{v_{d,\text{pll}}} \right) + k_{i,\text{pll}} \varepsilon_{\text{pll}} \tag{1e} \\ +\omega_{\text{pll}} &= \delta\omega_{\text{pll}} + \omega_{\text{sys}} \tag{1f} \\ +v_{d,\text{out}} + jv_{q,\text{out}} &= (v_r + jv_i)e^{-\delta\theta_\text{pll}} \tag{1g} +\end{align}\]

    on which $v_r + jv_i$ is the voltage in the grid reference frame on which the PLL is measuring (i.e. point of common coupling), that could be in the capacitor of an LCL filter or the last branch of such filter.

    Reduced Order Phase-Locked Loop (PLL) [ReducedOrderPLL]

    The following equations presents a simplified PLL used to estimate the frequency and PLL angle of the grid. The model attempts to steer the voltage in the q-axis to zero (i.e. lock the q-axis to zero) using a PI controller. With that the equations are given by:

    \[\begin{align} +\dot{v}_{q,\text{pll}} &= \omega_{\text{lp}} \left [v_{q,\text{out}} - v_{q,\text{pll}} \right] \tag{2a} \\ +\dot{\varepsilon}_{\text{pll}} &= v_{q,\text{pll}} \tag{2b} \\ +\dot{\theta}_{\text{pll}} &= \Omega_b \delta \omega_{\text{pll}} \tag{2c} +\end{align}\]

    with

    \[\begin{align} +\delta\omega_{\text{pll}} &= 1.0 - \omega_{\text{sys}} + k_{p,\text{pll}} v_{q,\text{pll}} + k_{i,\text{pll}} \varepsilon_{\text{pll}} \tag{2d} \\ +\omega_{\text{pll}} &= \delta\omega_{\text{pll}} + \omega_{\text{sys}} \tag{2e} \\ +v_{d,\text{out}} + jv_{q,\text{out}} &= (v_r + jv_i)e^{-\delta\theta_\text{pll}} \tag{2f} +\end{align}\]

    on which $v_r + jv_i$ is the voltage in the grid reference frame on which the PLL is measuring (i.e. point of common coupling), that could be in the capacitor of an LCL filter or the last branch of such filter.

    diff --git a/previews/PR360/component_models/inner_control/index.html b/previews/PR360/component_models/inner_control/index.html new file mode 100644 index 000000000..aaad26acb --- /dev/null +++ b/previews/PR360/component_models/inner_control/index.html @@ -0,0 +1,44 @@ + +Inner Control · PowerSimulationsDynamics.jl

    Inner Loop Controls

    This component defines voltage and current controllers to generate the reference signal for the converter. Although in many controls the current and voltage control are separate blocks we propose a more general control approach that considers them as a joint control logic.

    Integrated Virtual Impedance, Voltage and Current Controller [VoltageModeControl]

    The following model receives both the outer loop control frequency and reference voltage signal to generate the reference signal for the converters. The virtual impedance plays a similar role of the impedance of a synchronous generator. A PI voltage controller is used to generate the current signal that is used in the PI current controller to finally generate the voltage reference signal for the converters.

    \[\begin{align*} + \dot{\xi}_d &= v_{d,\text{vi}}^{\text{ref}} - v_d \tag{1a} \\ + \dot{\xi}_q &= v_{q,\text{vi}}^{\text{ref}} - v_q \tag{1b} \\ + \dot{\gamma}_d &= i_{d,\text{cv}}^{\text{ref}} - i_{d,\text{cv}} \tag{1c} \\ + \dot{\gamma}_q &= i_{q,\text{cv}}^{\text{ref}} - i_{q,\text{cv}} \tag{1d} \\ + \dot{\phi}_d &= \omega_{\text{ad}}(v_d - \phi_d) \tag{1e} \\ + \dot{\phi}_q &= \omega_{\text{ad}}(v_q - \phi_q) \tag{1f} +\end{align*}\]

    with

    \[\begin{align} + v_{d,\text{vi}}^{\text{ref}} &= v_{\text{olc}}^{\text{ref}} - r_v i_d + \omega_{\text{olc}} l_v i_q \tag{1g} \\ + v_{q,\text{vi}}^{\text{ref}} &= - r_v i_q - \omega_{\text{olc}} l_v i_d \tag{1h} \\ + i_{d,\text{cv}}^{\text{ref}} &= k_{pv}\left(v_{d,\text{vi}}^{\text{ref}} - v_d\right) + k_{iv} \xi_d - c_f \omega_{\text{olc}} v_q + k_{\text{ffi}}i_d \tag{1i} \\ + i_{q,\text{cv}}^{\text{ref}} &= k_{pv}\left(v_{q,\text{vi}}^{\text{ref}} - v_q\right) + k_{iv} \xi_q + c_f \omega_{\text{olc}} v_d + k_{\text{ffi}}i_q \tag{1j} \\ + v_d^{\text{ref-signal}} &= k_{pc} \left(i_{d,\text{cv}}^{\text{ref}} - i_{d,\text{cv}}\right) + k_{ic} \gamma_d - \omega_{\text{olc}} l_f i_{q,\text{cv}} + k_{\text{ffv}}v_d - k_{\text{ad}}(v_d - \phi_d) \tag{1k} \\ + v_q^{\text{ref-signal}} &= k_{pc} \left(i_{q,\text{cv}}^{\text{ref}} - i_{q,\text{cv}}\right) + k_{ic} \gamma_q + \omega_{\text{olc}} l_f i_{d,\text{cv}} + k_{\text{ffv}}v_q - k_{\text{ad}}(v_q - \phi_q) \tag{1l} +\end{align}\]

    In here the transformation to the $dq$ reference frame is using the outer-loop reference angle as:

    \[\begin{align*} +v_d + jv_q = (v_r + jv_i)e^{-j\delta\theta_{olc}} \\ +i_d + ji_q = (i_r + ji_i)e^{-j\delta\theta_{olc}} +\end{align*}\]

    that again $v_r + jv_i$ could be in the capacitor or the last branch of the filter (i.e. the point of common coupling). For LCL filters it is considered in the capacitor. In the case of the converter, the transformation is directly

    \[\begin{align*} +i_{d,\text{cv}} + ji_{q,\text{cv}} = (i_{r,\text{cv}} + ji_{i,\text{cv}})e^{-j\delta\theta_{olc}} +\end{align*}\]

    Current Mode Controller [CurrentModeControl]

    The following model receives the current reference (in $dq$ axis) from an outer loop controller that outputs current references such as the PI outer controller used for grid following inverters. A PI current controller is used to generate the voltage reference signal for the converters.

    \[\begin{align*} + \dot{\gamma}_d &= i_{d,\text{cv}}^{\text{ref}} - i_{d,\text{cv}} \tag{2a} \\ + \dot{\gamma}_q &= i_{q,\text{cv}}^{\text{ref}} - i_{q,\text{cv}} \tag{2b} \\ +\end{align*}\]

    with

    \[\begin{align} + v_d^{\text{ref-signal}} &= k_{pc} \left(i_{d,\text{cv}}^{\text{ref}} - i_{d,\text{cv}}\right) + k_{ic} \gamma_d - \omega_{\text{olc}} l_f i_{q,\text{cv}} + k_{\text{ffv}}v_d \tag{2b} \\ + v_q^{\text{ref-signal}} &= k_{pc} \left(i_{q,\text{cv}}^{\text{ref}} - i_{q,\text{cv}}\right) + k_{ic} \gamma_q + \omega_{\text{olc}} l_f i_{d,\text{cv}} + k_{\text{ffv}}v_q \tag{2c} +\end{align}\]

    The transformation for the converter current is computed as:

    \[\begin{align*} +i_{d,\text{cv}} + ji_{q,\text{cv}} = (i_{r,\text{cv}} + ji_{i,\text{cv}})e^{-j\theta_{olc}} +\end{align*}\]

    In here $\theta_{olc}$ is the outer-loop angle. In the case of grid-following models, this angle is equal to the angle provided from the PLL.

    Generic Renewable Inner Controller Type B [RECurrentControlB]

    This models the inner control part of the REECB model. The equations (without limiters) when Q_Flag = 1 are:

    \[\begin{align} + T_{rv} \dot{V}_\text{t,flt} &= V_t - \dot{V}_\text{t,flt} \tag{3a} \\ + \dot{\xi}_{icv} &= V_\text{oc,qcmd} \tag{3b} +\end{align}\]

    on which $V_\text{oc,qcmd}$ comes from the Outer Controller and the output current commands $I_\text{pcmd}$ and $I_\text{qcmd}$ are computed as:

    \[\begin{align} + I_\text{pcmd} &= I_\text{oc, pcmd} \tag{3c} \\ + I_\text{qcmd} &= I_{icv} + I_\text{qinj} \tag{3d} \\ + I_{icv} &= K_{vp} V_\text{oc,qcmd} + K_{vi} \xi_{icv} \tag{3e} \\ + I_{\text{qinj}} &= K_{qv} (V_\text{ref0} - V_\text{t,flt}) \tag{3f} +\end{align}\]

    The equations when Q_Flag = 0 are:

    \[\begin{align} + T_{rv} \dot{V}_\text{t,flt} &= V_t - \dot{V}_\text{t,flt} \tag{3g} \\ + T_{iq} \dot{I}_{icv} &= I_\text{oc,qcmd} - I_{icv} \tag{3h} +\end{align}\]

    on which $I_\text{oc,qcmd}$ comes from the Outer Controller and the output current commands $I_\text{pcmd}$ and $I_\text{qcmd}$ are computed as:

    \[\begin{align} + I_\text{pcmd} &= I_\text{oc, pcmd} \tag{3i} \\ + I_\text{qcmd} &= I_{icv} + I_\text{qinj} \tag{3j} \\ + I_{\text{qinj}} &= K_{qv} (V_\text{ref0} - V_\text{t,flt}) \tag{3k} +\end{align}\]

    diff --git a/previews/PR360/component_models/loads/index.html b/previews/PR360/component_models/loads/index.html new file mode 100644 index 000000000..8e0144569 --- /dev/null +++ b/previews/PR360/component_models/loads/index.html @@ -0,0 +1,64 @@ + +Load Models · PowerSimulationsDynamics.jl

    Here we discuss the models used to describe load modeling in PowerSimulationsDynamics.jl. In a similar fashion of other devices, loads will withdraw power (i.e. current) from the current-injection balances at the nodal level. Based on the specified parameters and model chosen, the equations for computing such withdrawal will change.

    Static Loads (or Algebraic Loads)

    ZIP + Exponential Load Model

    PowerSimulationsDynamics.jl uses all the static ZIP and exponential loads at each bus to obtain a single structure that creates an aggregate ZIP load model and a collection of all exponential loads.

    The ZIP load model given by:

    \[\begin{align} +P_\text{zip} &= P_\text{power} + P_\text{current} \cdot \frac{V}{V_0} + P_\text{impedance} \cdot \left(\frac{V}{V_0}\right)^2 \tag{1a}\\ +Q_\text{zip} &= Q_\text{power} + Q_\text{current} \cdot \frac{V}{V_0} + Q_\text{impedance} \cdot \left(\frac{V}{V_0}\right)^2\tag{1b} +\end{align}\]

    with $V = \sqrt{V_r^2 + V_i^2}$ and $V_0$ the voltage magnitude from the power flow solution.

    The current taken for the load is computed as:

    \[\begin{align} +I_\text{zip} &= \frac{(P_\text{zip} + j Q_\text{zip})^*}{(V_r + j V_i)^*}\tag{1c} \\ +I_\text{zip} &= \frac{P_\text{zip} - j Q_\text{zip}}{V_r - j V_i}\tag{1d} +\end{align}\]

    For constant impedance load, the current obtained is:

    \[\begin{align} +I_\text{re}^z &= \frac{1}{V_0^2} \cdot (V_r \cdot P_\text{impedance} + V_i \cdot Q_\text{impedance})\tag{1e} \\ +I_\text{im}^z &= \frac{1}{V_0^2} \cdot (V_i \cdot P_\text{impedance} - V_r \cdot Q_\text{impedance})\tag{1f} +\end{align}\]

    For constant current load, the current obtained is:

    \[\begin{align} +I_\text{re}^i &= \frac{1}{V_0} \cdot \frac{V_r * P_\text{current} + V_i * Q_\text{current}}{V} \tag{1g}\\ +I_\text{im}^i &= \frac{1}{V_0} \cdot \frac{V_i * P_\text{current} - V_r * Q_\text{current}}{V} \tag{1h} +\end{align}\]

    For constant power load, the current obtained is:

    \[\begin{align} +I_\text{re}^p = \frac{V_r \cdot P_\text{power} + V_i \cdot Q_\text{power}}{V^2} \tag{1i} \\ +I_\text{im}^p = \frac{V_i \cdot P_\text{power} - V_r \cdot Q_\text{power}}{V^2} \tag{1j} +\end{align}\]

    Then the total current withdrawed from the ZIP load model is simply

    \[\begin{align} +I_\text{zip}^\text{re} &= I_\text{re}^z + I_\text{re}^i + I_\text{re}^p \tag{1k} \\ +I_\text{zip}^\text{im} &= I_\text{im}^z + I_\text{im}^i + I_\text{im}^p \tag{1l} +\end{align}\]

    On the case of Exponential Loads, the model is given by:

    \[\begin{align} +P_\text{exp} = P_0 \cdot \left(\frac{V}{V_0}\right)^\alpha \tag{1m}\\ +Q_\text{exp} = Q_0 \cdot \left(\frac{V}{V_0}\right)^\beta \tag{1n} +\end{align}\]

    The current taken for the load is computed as:

    \[\begin{align} +I_\text{exp} &= \frac{(P_\text{exp} + j Q_\text{exp})^*}{(V_r + j V_i)^*} \tag{1o} \\ +I_\text{exp} &= \frac{P_\text{exp} - j Q_\text{exp}}{V_r - j V_i} \tag{1p} +\end{align}\]

    that results:

    \[\begin{align} +I_\text{exp}^\text{re} &= V_r \cdot P_0 \cdot \frac{V^{\alpha - 2}}{V_0^\alpha} + V_i \cdot Q_0 \cdot \frac{V^{\beta - 2}}{V_0^\beta} \tag{1q}\\ +I_\text{exp}^\text{im} &= V_i \cdot P_0 \cdot \frac{V^{\alpha - 2}}{V_0^\alpha} - V_r \cdot Q_0 \cdot \frac{V^{\beta - 2}}{V_0^\beta} \tag{1r} +\end{align}\]

    Dynamic loads

    5th-order Single Cage Induction Machine [SingleCageInductionMachine]

    The following model is used to model a 5th-order induction machine with a quadratic relationship speed-torque. Refer to "Analysis of Electric Machinery and Drive Systems" by Paul Krause, Oleg Wasynczuk and Scott Sudhoff for the equations derivation

    \[\begin{align} +\dot{\psi}_{qs} &= \Omega_b (v_{qs} - \omega_\text{sys} \psi_{ds} - R_s i_{qs}) \tag{2a}\\ +\dot{\psi}_{ds} &= \Omega_b (v_{ds} + \omega_\text{sys} \psi_{qs} - R_s i_{ds}) \tag{2b} \\ +\dot{\psi}_{qr} &= \Omega_b \left(v_{qr} - (\omega_\text{sys} - \omega_r) \psi_{dr} + \frac{R_r}{X_{lr}} (\psi_{mq} - \psi_{qr})\right) \tag{2c}\\ +\dot{\psi}_{dr} &= \Omega_b \left(v_{dr} + (\omega_\text{sys} - \omega_r) \psi_{qr} + \frac{R_r}{X_{lr}} (\psi_{md} - \psi_{dr})\right) \tag{2d}\\ +\dot{\omega}_r &= \frac{1}{2H} (\tau_e - \tau_{m0}(A \omega_r^2 + B \omega_r + C)) \tag{2e} +\end{align}\]

    where:

    \[\begin{align*} +X_{ad} = X_{aq} &= \left(\frac{1}{X_m} + \frac{1}{X_{ls}} + \frac{1}{X_{lr}}\right)^{-1} \\ +v_{qs} &= V_i^\text{bus} \\ +v_{ds} &= V_r^\text{bus} \\ +v_{qr} = v_{dr} &= 0 \\ +\psi_{mq} &= X_{aq} \left(\frac{\psi_{qs}}{X_{ls}}+ \frac{\psi_{qr}}{X_{lr}}\right) \\ +\psi_{md} &= X_{ad} \left(\frac{\psi_{ds}}{X_{ls}}+ \frac{\psi_{dr}}{X_{lr}}\right) \\ +i_{qs} &= \frac{1}{X_{ls}} (\psi_{qs} - \psi_{mq}) \\ +i_{ds} &= \frac{1}{X_{ls}} (\psi_{ds} - \psi_{md}) \\ +\tau_e &= \psi_{ds} i_{qs} - \psi_{qs} i_{ds} +\end{align*}\]

    Finally, the withdrawed current from the bus is:

    \[\begin{align*} +I_r = \left(\frac{S_\text{motor}}{S_\text{base}}\right) (i_{ds} - v_{qs} B_{sh}) \\ +I_i = \left(\frac{S_\text{motor}}{S_\text{base}}\right) (i_{qs} + v_{ds} B_{sh}) +\end{align*}\]

    3rd-order Single Cage Induction Machine [SimplifiedSingleCageInductionMachine]

    The following models approximates the stator fluxes dynamics of the 5th-order model by using algebraic equations.

    \[\begin{align} +\dot{\psi}_{qr} &= \Omega_b \left(v_{qr} - (\omega_\text{sys} - \omega_r) \psi_{dr} - R_r i_{qr} \right) \tag{3a} \\ +\dot{\psi}_{dr} &= \Omega_b \left(v_{dr} + (\omega_\text{sys} - \omega_r) \psi_{qr} - R_r i_{dr}\right) \tag{3b} \\ +\dot{\omega}_r &= \frac{1}{2H} (\tau_e - \tau_{m0}(A \omega_r^2 + B \omega_r + C)) \tag{3c} +\end{align}\]

    where

    \[\begin{align*} +v_{qs} &= V_i^\text{bus} \\ +v_{ds} &= V_r^\text{bus} \\ +v_{qr} = v_{dr} &= 0 \\ +i_{qs} &= \frac{1}{R_s^2 + \omega_\text{sys}^2 X_p^2} \left( (R_s v_{qs} - \omega_\text{sys} X_p v_{ds}) - \left(R_s \omega_\text{sys} \frac{X_m}{X_{rr}} \psi_{dr} + \omega_\text{sys}^2 X_p \frac{X_m}{X_{rr}} \psi_{qr} \right) \right) \\ +i_{ds} &= \frac{1}{R_s^2 + \omega_\text{sys}^2 X_p^2} \left( (R_s v_{ds} + \omega_\text{sys} X_p v_{qs}) - \left(-R_s \omega_\text{sys} \frac{X_m}{X_{rr}} \psi_{qr} + \omega_\text{sys}^2 X_p \frac{X_m}{X_{rr}} \psi_{dr} \right) \right) \\ +i_{qr} &= \frac{1}{X_{rr}} (\psi_{qr} - X_m i_{qs}) \\ +i_{dr} &= \frac{1}{X_{rr}} (\psi_{dr} - X_m i_{ds}) \\ +\tau_e &= \psi_{qr} i_{dr} - \psi_{dr} i_{qr} +\end{align*}\]

    Finally, the withdrawed current from the bus is:

    \[\begin{align*} +I_r = \left(\frac{S_\text{motor}}{S_\text{base}}\right) (i_{ds} - v_{qs} B_{sh}) \\ +I_i = \left(\frac{S_\text{motor}}{S_\text{base}}\right) (i_{qs} + v_{ds} B_{sh}) +\end{align*}\]

    diff --git a/previews/PR360/component_models/machines/index.html b/previews/PR360/component_models/machines/index.html new file mode 100644 index 000000000..f8d701862 --- /dev/null +++ b/previews/PR360/component_models/machines/index.html @@ -0,0 +1,103 @@ + +Machine · PowerSimulationsDynamics.jl

    Machines

    The machine component describes the stator-rotor electromagnetic dynamics.

    Classical Model (Zero Order) [BaseMachine]

    This is the classical order model that does not have differential equations in its machine model ($\delta$ and $\omega$ are defined in the shaft):

    \[\begin{align} + \left[ \begin{array}{c} i_d \\ i_q \end{array} \right] &= \left[ \begin{array}{cc} r_a & -x_d' \\ x_d' & r_a \end{array} \right]^{-1} \left[ \begin{array}{c} -v_d \\ e_q' - v_q \end{array} \right] \tag{1a}\\ +p_e \approx \tau_e &= (v_q + r_a i_q)i_q + (v_d + r_ai_d)i_d \tag{1b} +\end{align}\]

    One d- One q- Model (2nd Order) [OneDOneQMachine]

    This model includes two transient emf with their respective differential equations:

    \[\begin{align} +\dot{e}_q' &= \frac{1}{T_{d0}'} \left[-e_q' + (x_d-x_d')i_d + v_f\right] \tag{2a}\\ +\dot{e}_d' &= \frac{1}{T_{q0}'} \left[-e_d' + (x_q-x_q')i_q \right] \tag{2b}\\ + \left[ \begin{array}{c} i_d \\ i_q \end{array} \right] &= \left[ \begin{array}{cc} r_a & -x_q' \\ x_d' & r_a \end{array} \right]^{-1} \left[ \begin{array}{c} e_d'-v_d \\ e_q' - v_q \end{array} \right] \tag{2c}\\ +p_e \approx \tau_e &= (v_q + r_a i_q)i_q + (v_d + r_ai_d)i_d \tag{2d} +\end{align}\]

    Marconato Machine (6th Order) [MarconatoMachine]

    The Marconato model defines 6 differential equations, two for stator fluxes and 4 for transient and subtransient emfs:

    \[\begin{align} +\dot{\psi}_d &= \Omega_b(r_ai_d + \omega \psi_q + v_d) \tag{3a} \\ +\dot{\psi}_q &= \Omega_b(r_ai_q - \omega \psi_d + v_q) \tag{3b} \\ +\dot{e}_q' &= \frac{1}{T_{d0}'} \left[-e_q' - (x_d-x_d'-\gamma_d)i_d + \left(1- \frac{T_{AA}}{T_{d0}'} \right) v_f\right] \tag{3c}\\ +\dot{e}_d' &= \frac{1}{T_{q0}'} \left[-e_d' + (x_q-x_q'-\gamma_q)i_q \right] \tag{3d}\\ +\dot{e}_q'' &= \frac{1}{T_{d0}''} \left[-e_q'' + e_q' - (x_d'-x_d''+\gamma_d)i_d + \frac{T_{AA}}{T_{d0}'}v_f \right] \tag{3e} \\ +\dot{e}_d'' &= \frac{1}{T_{q0}''} \left[-e_d'' + e_d' + (x_q'-x_q''+\gamma_q)i_q \right] \tag{3f} \\ +i_d &= \frac{1}{x_d''} (e_q'' - \psi_d) \tag{3g} \\ +i_q &= \frac{1}{x_q''} (-e_d'' - \psi_q) \tag{3h} \\ +\tau_e &= \psi_d i_q - \psi_q i_d \tag{3i} +\end{align}\]

    with

    \[\begin{align*} + \gamma_d &= \frac{T_{d0}'' x_d''}{T_{d0}' x_d'} (x_d - x_d') \\ + \gamma_q &= \frac{T_{q0}'' x_q''}{T_{q0}' x_q'} (x_q - x_q') +\end{align*}\]

    Simplified Marconato Machine (4th Order) [SimpleMarconatoMachine]

    This model neglects the derivative of stator fluxes ($\dot{\psi}_d$ and $\dot{\psi}_q$) and assume that the rotor speed stays close to 1 pu ($\omega\psi_{d}=\psi_{d}$ and $\omega\psi_{q}=\psi_{q}$) that allows to remove the stator fluxes variables from the Marconato model.

    \[\begin{align} +\dot{e}_q' &= \frac{1}{T_{d0}'} \left[-e_q' - (x_d-x_d'-\gamma_d)i_d + \left(1- \frac{T_{AA}}{T_{d0}'} \right) v_f\right] \tag{4a}\\ +\dot{e}_d' &= \frac{1}{T_{q0}'} \left[-e_d' + (x_q-x_q'-\gamma_q)i_q \right] \tag{4b}\\ +\dot{e}_q'' &= \frac{1}{T_{d0}''} \left[-e_q'' + e_q' - (x_d'-x_d''+\gamma_d)i_d + \frac{T_{AA}}{T_{d0}'}v_f \right] \tag{4c} \\ +\dot{e}_d'' &= \frac{1}{T_{q0}''} \left[-e_d'' + e_d' + (x_q'-x_q''+\gamma_q)i_q \right] \tag{4d} \\ +\left[ \begin{array}{c} i_d \\ i_q \end{array} \right] &= \left[ \begin{array}{cc} r_a & -x_q'' \\ x_d'' & r_a \end{array} \right]^{-1} \left[ \begin{array}{c} e_d''-v_d \\ e_q'' - v_q \end{array} \right] \tag{4e}\\ +p_e \approx \tau_e &= (v_q + r_a i_q)i_q + (v_d + r_ai_d)i_d \tag{4f} +\end{align}\]

    with

    \[\begin{align*} + \gamma_d &= \frac{T_{d0}'' x_d''}{T_{d0}' x_d'} (x_d - x_d') \\ + \gamma_q &= \frac{T_{q0}'' x_q''}{T_{q0}' x_q'} (x_q - x_q') +\end{align*}\]

    Anderson-Fouad Machine (6th Order) [AndersonFouadMachine]

    The Anderson-Fouad model also defines 6 differential equations, two for stator fluxes and 4 for transient and subtransient emfs and is derived from the Marconato model by defining $\gamma_d \approx \gamma_q \approx T_{AA} \approx 0$:

    \[\begin{align} +\dot{\psi}_d &= \Omega_b(r_ai_d + \omega \psi_q + v_d) \tag{5a} \\ +\dot{\psi}_q &= \Omega_b(r_ai_q - \omega \psi_d + v_q) \tag{5b} \\ +\dot{e}_q' &= \frac{1}{T_{d0}'} \left[-e_q' - (x_d-x_d')i_d + v_f\right] \tag{5c}\\ +\dot{e}_d' &= \frac{1}{T_{q0}'} \left[-e_d' + (x_q-x_q')i_q \right] \tag{5d}\\ +\dot{e}_q'' &= \frac{1}{T_{d0}''} \left[-e_q'' + e_q' - (x_d'-x_d'')i_d \right] \tag{5e} \\ +\dot{e}_d'' &= \frac{1}{T_{q0}''} \left[-e_d'' + e_d' + (x_q'-x_q'')i_q \right] \tag{5f} \\ +i_d &= \frac{1}{x_d''} (e_q'' - \psi_d) \tag{5g} \\ +i_q &= \frac{1}{x_q''} (-e_d'' - \psi_q) \tag{5h} \\ +\tau_e &= \psi_d i_q - \psi_q i_d \tag{5i} +\end{align}\]

    Simplified Anderson-Fouad Machine (4th Order) [SimpleAFMachine]

    Similar to the Simplified Marconato Model, this model neglects the derivative of stator fluxes ($\dot{\psi}_d$ and $\dot{\psi}_q$) and assume that the rotor speed stays close to 1 pu ($\omega \psi_d = \psi_d$ and $\omega \psi_q = \psi_q$) that allows to remove the stator fluxes variables from the model:

    \[\begin{align} +\dot{e}_q' &= \frac{1}{T_{d0}'} \left[-e_q' - (x_d-x_d')i_d + v_f\right] \tag{6a}\\ +\dot{e}_d' &= \frac{1}{T_{q0}'} \left[-e_d' + (x_q-x_q')i_q \right] \tag{6b}\\ +\dot{e}_q'' &= \frac{1}{T_{d0}''} \left[-e_q'' + e_q' - (x_d'-x_d'')i_d \right] \tag{6c} \\ +\dot{e}_d'' &= \frac{1}{T_{q0}''} \left[-e_d'' + e_d' + (x_q'-x_q'')i_q \right] \tag{6d} \\ +\left[ \begin{array}{c} i_d \\ i_q \end{array} \right] &= \left[ \begin{array}{cc} r_a & -x_q'' \\ x_d'' & r_a \end{array} \right]^{-1} \left[ \begin{array}{c} e_d''-v_d \\ e_q'' - v_q \end{array} \right] \tag{6e}\\ +p_e \approx \tau_e &= (v_q + r_a i_q)i_q + (v_d + r_ai_d)i_d \tag{6f} +\end{align}\]

    Round Rotor Machine (4th Order) [RoundRotorQuadratic, RoundRotorExponential]

    This model represents the traditional round rotor models GENROU/GENROE models implemented in PSLF/PSSE/PowerWorld. Similar to the Simplified Marconato Model, this model neglects the derivative of stator fluxes ($\dot{\psi}_d$ and $\dot{\psi}_q$). Round rotor machines must satisfy $x_d'' = x_q''$.

    \[\begin{align} +\dot{e}_q' &= \frac{1}{T_{d0}'} \left[v_f - X_{ad}I_{fd}\right] \tag{7a}\\ +\dot{e}_d' &= \frac{1}{T_{q0}'} \left[-X_{aq}I_{1q} \right] \tag{7b}\\ +\dot{\psi}_{kd} &= \frac{1}{T_{d0}''} \left[-\psi_{kd} + e_q' - (x_d'-x_l)i_d \right] \tag{7c} \\ +\dot{\psi}_{kq} &= \frac{1}{T_{q0}''} \left[-\psi_{kq} + e_d' + (x_q'-x_l)i_q \right] \tag{7d} \\ +\end{align}\]

    with:

    \[\begin{align} +\gamma_{d1} &= \frac{x_d'' - x_l}{x_d' - x_l} \tag{7e}\\ +\gamma_{q1} &= \frac{x_q'' - x_l}{x_q' - x_l} \tag{7f}\\ +\gamma_{d2} &= \frac{x_d' - x_d''}{(x_d'-x_l)^2} \tag{7g}\\ +\gamma_{q2} &= \frac{x_q' - x_q''}{(x_q' - x_l)^2} \tag{7h}\\ +\gamma_{qd} &= \frac{x_q - x_l}{x_d - x_l} \tag{7i}\\ +\psi_q'' &= \gamma_{q1} e_d' + \psi_{kq} (1 - \gamma_{q1}) \tag{7j}\\ +\psi_d'' &= \gamma_{d1} e_q' + \gamma_{d2} (x_d' - x_l) \psi_{kd} \tag{7k}\\ +\psi'' &= \sqrt{(\psi_d'')^2 + (\psi_q'')^2} \tag{7l}\\ +\left[ \begin{array}{c} i_d \\ i_q \end{array} \right] &= \left[ \begin{array}{cc} -r_a & x_q'' \\ -x_d'' & r_a \end{array} \right]^{-1} \left[ \begin{array}{c} v_d - \psi_q'' \\ -v_q + \psi_d'' \end{array} \right] \tag{7m}\\ +X_{ad}I_{fd} &= e_q' + (x_d - x_d') (\gamma_{d1} i_d - \gamma_{d2} \psi_{kd} + \gamma_{d2} + e_q') + \text{Se}(\psi'') \psi_d'' \tag{7n}\\ +X_{aq}I_{1q} &= e_d' + (x_q - x_q') (\gamma_{q2} e_d' - \gamma_{q2}\psi_{kq} - \gamma_{q1} i_q) + \text{Se}(\psi'') \psi_q'' \gamma_{qd} \tag{7o} \\ +\tau_e &= i_d (r_a i_d + v_d) + i_q(r_a i_q + v_q) \tag{7p} +\end{align}\]

    The difference between GENROU and GENROE occurs in which additive saturation function $\text{Se}(\psi'')$ is used. Input data is provided by the saturation values at $\psi'' = 1.0$ and $\psi'' = 1.2$ p.u. For the GENROU model, the function used is:

    \[\begin{align} +\text{Se}(\psi'') &= \frac{B(\psi'' - A)^2 }{\psi''} \tag{7q} +\end{align}\]

    and for the GENROE model the function used is:

    \[\begin{align} +\text{Se}(\psi'') &= B(\psi'')^A \tag{7r} +\end{align}\]

    The parameters $A$ and $B$ for each function are computed using the two points given $(1.0, \text{Se}(1.0))$ and $(1.2, \text{Se}(1.2))$.

    Salient Pole Machine (3rd Order) [SalientPoleQuadratic, SalientPoleExponential]

    This model represents the traditional round rotor models GENSAL/GENSAE models implemented in PSLF/PSSE/PowerWorld. Similar to the GENROU Model, this model neglects the derivative of stator fluxes ($\dot{\psi}_d$ and $\dot{\psi}_q$).

    \[\begin{align} +\dot{e}_q' &= \frac{1}{T_{d0}'} \left[v_f - X_{ad}I_{fd}\right] \tag{8a}\\ +\dot{\psi}_{kd} &= \frac{1}{T_{d0}''} \left[-\psi_{kd} + e_q' - (x_d'-x_l)i_d \right] \tag{8b} \\ +\dot{\psi}_{q}'' &= \frac{1}{T_{q0}''} \left[-\psi_{q}'' - (x_q-x_q'')i_q \right] \tag{8c} \\ +\end{align}\]

    with:

    \[\begin{align} +\gamma_{d1} &= \frac{x_d'' - x_l}{x_d' - x_l} \tag{8d}\\ +\gamma_{q1} &= \frac{x_q'' - x_l}{x_q' - x_l} \tag{8e}\\ +\gamma_{d2} &= \frac{x_d' - x_d''}{(x_d'-x_l)^2} \tag{8f}\\ +\psi_d'' &= \gamma_{d1} e_q' + \gamma_{q1} \psi_{kd} \tag{8g}\\ +\left[ \begin{array}{c} i_d \\ i_q \end{array} \right] &= \left[ \begin{array}{cc} -r_a & x_q'' \\ -x_d'' & r_a \end{array} \right]^{-1} \left[ \begin{array}{c} v_d - \psi_q'' \\ -v_q + \psi_d'' \end{array} \right] \tag{8h}\\ +X_{ad}I_{fd} &= e_q' + \text{Se}(e_q') e_q' + (x_d - x_d') (i_d + \gamma_{d2} (e_q' - \psi_{kd} - (x_d' - x_l)i_d) \tag{8i}\\ +\tau_e &= i_d (r_a i_d + v_d) + i_q(r_a i_q + v_q) \tag{8j} +\end{align}\]

    The difference between GENSAL and GENSAE occurs in which additive saturation function $\text{Se}(e_q')$ is used. Input data is provided by the saturation values at $e_q' = 1.0$ and $e_q' = 1.2$ p.u. For the GENSAL model, the function used is:

    \[\begin{align} +\text{Se}(e_q') &= \frac{B(e_q' - A)^2 }{\e_q'} \tag{8k} +\end{align}\]

    and for the GENSAE model the function used is:

    \[\begin{align} +\text{Se}(e_q') &= B(e_q')^A \tag{8l} +\end{align}\]

    The parameters $A$ and $B$ for each function are computed using the two points given $(1.0, \text{Se}(1.0))$ and $(1.2, \text{Se}(1.2))$.

    SauerPai Machine (6th Order) [SauerPaiMachine]

    The Sauer Pai model defines 6 differential equations as follows:

    \[\begin{align} +\dot{\psi}_d &= \Omega_b(r_ai_d + \omega \psi_q + v_d) \tag{9a} \\ +\dot{\psi}_q &= \Omega_b(r_ai_q - \omega \psi_d + v_q) \tag{9b} \\ +\dot{e}_q' &= \frac{1}{T_{d0}'} \left[(-e_q' - (x_d - x_d')(i_d + \gamma_d2 * \dot{\psi}_d'') + v_f)] \tag{9c}\\ +\dot{e}_q' &= \frac{1}{T_{q0}'} \left[(-e_d' + (x_q - x_q')(i_q + \gamma_q2 * \dot{\psi}_q''))] \tag{9d}\\ +\dot{\psi}_d'' &= \frac{1}{T_{d0}''} \left[(-\psi_d'' + e_q' - (x_d' - x_l)*i_d)] \tag{9e} \\ +\dot{\psi}_q'' &= \frac{1}{T_{q0}''} \left[(-\psi_q'' - e_d' - (x_q' - x_l)*i_q)] \tag{9f} \\ +i_d &= \frac{1}{x_d''} (\gamma_d1 * e_q' - \psi_d + (1 - \gamma_d1) * \psi_d'') \tag{9g} \\ +i_q &= \frac{1}{x_q''} ((-\gamma_q1 * e_d' - \psi_q + (1 - \gamma_q1) * \psi_q'') \tag{9h} \\ +\tau_e &= \psi_d i_q - \psi_q i_d \tag{9i} +\end{align}\]

    with

    \[\begin{align*} + \gamma_d1 &= \frac{x_d'' - x_l}{x_d' - x_l} \\ + \gamma_q1 &= \frac{x_q'' - x_l}{x_q' - x_l} \\ + \gamma_d2 &= \frac{1 - \gamma_d1}{x_d' - x_l} \\ + \gamma_q2 &= \frac{1 - \gamma_q1}{x_q' - x_l} +\end{align*}\]

    diff --git a/previews/PR360/component_models/network/index.html b/previews/PR360/component_models/network/index.html new file mode 100644 index 000000000..a17bd2b68 --- /dev/null +++ b/previews/PR360/component_models/network/index.html @@ -0,0 +1,13 @@ + +Network · PowerSimulationsDynamics.jl

    Network model

    Here we discuss the models used to describe the network in PowerSimulationsDynamics.jl. This is based on a standard current injection model as defined in Power System Modelling and Scripting. The numerical advantages of current injection models outweigh the complexities of implementing constant power loads for longer-term transient stability analysis. The network is defined in a synchronous reference frame (SRF), named the RI (real-imaginary) reference frame, rotating at the constant base frequency $\Omega_b$.

    In simple terms, PowerSimulationsDynamics.jl internally tracks the current-injection balances at the nodal level from all the devices on the system. Based on the buses and branches information, the system constructor computes the admittance matrix $\boldsymbol{Y}$ assuming nominal frequency and this is used for static branch modeling. The algebraic equations for the static portions of the network are as follows:

    \[ \begin{align} + 0 = \boldsymbol{i}(\boldsymbol{x}, \boldsymbol{v}) - \boldsymbol{Y}\boldsymbol{v} + \end{align}\]

    where $\boldsymbol{i} = i_r + ji_i$ is the vector of the sum of complex current injections from devices , $\boldsymbol{x}$ is the vector of states and $\boldsymbol{v} = v_r + jv_i$ is the vector of complex bus voltages. Equations (1) connect all the port variables, i.e., currents, defined for each injection device. Components that contribute to (1) by modifying the current $\boldsymbol{i}$ are (i) static injection devices, (ii) dynamic injection devices, and (iii) dynamic network branches. Components that contribute to modify the admittance matrix $\boldsymbol{Y}$ are static branches.

    Static Branches (or Algebraic Branches)

    Lines

    Each line is defined using a $\pi$ model connecting two buses $(n,m)$, with a series resistance $r$ and reactance $x$, and a shunt capacitance at both ends $(c_n, c_m)$. The values are already in system per unit. Then each branch contributes to the admittance matrix as follows:

    \[\begin{align} +Y_{nn} &+\!= \frac{1}{r+jx} + jc_n \\ +Y_{nm} &+\!= \frac{-1}{r+jx} \\ +Y_{mm} &+\!= \frac{1}{r+jx} + jc_m \\ +Y_{mn} &+\!= \frac{-1}{r+jx} \\ +\end{align}\]

    Two-Windings Transformers

    Similarly to lines these are defined by a series reactance and impedance. The equations are equivalently of the lines without the shunt capacitance.

    Dynamic Branches

    Dynamic network branches contribute directly to (1) by modifying the vector of complex currents. Their parameters are also the series resistance $r$ and reactance $x$, and a shunt capacitance at both ends $(c_n, c_m)$ for a line $\ell$. In addition, they define 3 new additional differential equations per line (6 in total for real and imaginary part):

    \[\begin{align} + \frac{l}{\Omega_b} \frac{d\boldsymbol{i}_{\ell}}{dt} &= (\boldsymbol{v}_n - \boldsymbol{v}_m) - (r+jl) \boldsymbol{i}_{\ell} \\ + \frac{c_n}{\Omega_b} \frac{d\boldsymbol{v}_n}{dt} &= \boldsymbol{i}_n^{\text{cap}} - jc_n\boldsymbol{v}_n \\ + \frac{c_m}{\Omega_b} \frac{d\boldsymbol{v}_m}{dt} &= \boldsymbol{i}_m^{\text{cap}} - jc_m\boldsymbol{v}_m +\end{align}\]

    Since all the values are in per unit, the reactance is equal to the inductance.

    A detail discussion about the effects of different line models in the modeling of inverters is presented in Grid Forming Inverter Small Signal Stability: Examining Role of Line and Voltage Dynamics

    diff --git a/previews/PR360/component_models/outer_control/index.html b/previews/PR360/component_models/outer_control/index.html new file mode 100644 index 000000000..063a4d862 --- /dev/null +++ b/previews/PR360/component_models/outer_control/index.html @@ -0,0 +1,69 @@ + +Outer Control · PowerSimulationsDynamics.jl

    Outer Loop Controls

    This component defines controllers for both active and reactive power. The joint design is based on the fact that many novel control techniques can be based on joint control of active and reactive power.

    Virtual Inertia and Q-droop [OuterControl]

    The following model represent a virtual synchronous machine model to represent how active power is going to be deployed. The constructor is OuterControl{VirtualInertia, ReactivePowerDroop}. It defines a new SRF denoted as $\theta_{\text{olc}}$ for the active power controller and uses a simple voltage droop for dispatching reactive power:

    \[\begin{align} + \dot{\omega}_{\text{olc}} &= \frac{p_{\text{ref}}}{T_a} - \frac{p_e}{T_a} - \frac{k_d(\omega_{\text{olc}} - \omega_{\text{pll}})}{T_a} - \frac{k_\omega(\omega_{\text{olc}} - \omega_{\text{ref}})}{T_a} \tag{1a} \\ + \dot{\theta}_{\text{olc}} &= \Omega_b (\omega_{\text{olc}} - \omega_{\text{sys}}) \tag{1b} \\ + \dot{q}_m &= \omega_f (q_e - q_m) \tag{1c} +\end{align}\]

    with

    \[\begin{align} + p_e &= v_ri_r + v_ii_i \tag{1d} \\ + q_e &= v_ii_r - v_ri_i \tag{1e} \\ + v_{\text{olc}}^{\text{ref}} &= v_{\text{ref}} + k_q(q_{\text{ref}} - q_m) \tag{1f} +\end{align}\]

    In this case, the measurement of power are being done in the capacitor of the LCL filter. However, depending on the model, this measurements could be different depending on where is the point of common coupling.

    Active Power Droop (P-droop) and Q-droop [OuterControl]

    The following model represent a $P\text{-}f$ droop model to represent how active power is going to be deployed. The constructor is OuterControl{ActivePowerControl, ReactivePowerDroop}. It defines a new SRF denoted as $\theta_{\text{olc}}$ for the active power controller and uses a simple voltage droop for dispatching reactive power. Both active and reactive power are measured via a low-pass filter:

    \[\begin{align} + \dot{\theta}_{\text{olc}} &= \Omega_b (\omega_{\text{olc}} - \omega_{\text{sys}}) \tag{2a} \\ + \dot{p}_m &= \omega_z (p_e - p_m) \tag{2b} \\ + \dot{q}_m &= \omega_f (q_e - q_m) \tag{2c} +\end{align}\]

    with

    \[\begin{align} + p_e &= v_ri_r + v_ii_i \tag{2d} \\ + q_e &= v_ii_r - v_ri_i \tag{2e} \\ + \omega_{\text{olc}} &= \omega_{\text{ref}} + R_p (p_{\text{ref}} - p_m) \tag{2f} \\ + v_{\text{olc}}^{\text{ref}} &= v_{\text{ref}} + k_q(q_{\text{ref}} - q_m) \tag{2g} +\end{align}\]

    In this case, the measurement of power are being done in the capacitor of the LCL filter. However, depending on the model, this measurements could be different depending on where is the point of common coupling.

    Active and Reactive Virtual Oscillator Controllers [OuterControl]

    The following model represents a Virtual Oscillator Controller for both active and reactive power to generate the voltage references that will be used in the Voltage Controller. The contructor is OuterControl{ActiveVirtualOscillator, ReactiveVirtualOscillator} It defines a new SRF denoted as $\theta_{\text{olc}}$ and a voltage reference $E_{\text{olc}}$. The equations are:

    \[\begin{align} + \dot{\theta}_{\text{olc}} &= \Omega_b (\omega_{\text{olc}} - \omega_{\text{sys}}) \tag{3a} \\ + \dot{E}_{olc} &= \Omega_b \left(\frac{k_1}{E_{oc}} (-\sin(\gamma) (p_\text{ref} - p_e) + \cos(\gamma)(q_\text{ref} - q_e)) + k_2 (V_\text{ref} - E_{oc}^2)E_{oc} \right) \tag{3b} \\ +\end{align}\]

    with

    \[\begin{align} + \gamma &= \psi - \frac{\pi}{2} \tag{3c} \\ + \omega_{\text{olc}} &= \omega_{\text{sys}} + \frac{k_1}{E_{oc}^2} \left(\cos(\gamma) (p_\text{ref} - p_e) + \sin(\gamma)(q_\text{ref} - q_e) \right) \tag{3d} \\ + p_e &= v_ri_r + v_ii_i \tag{3e} \\ + q_e &= v_ii_r - v_ri_i \tag{3f} \\ +\end{align}\]

    Active and Reactive Power PI Controllers (Grid Following) [OuterControl]

    The following model represents a PI controller for both active and reactive power to generate the current references that will be used in the Current Controller of the inner control CurrentModeControl. The constructor is OuterControl{ActivePowerPI, ReactivePowerPI}. The equations are:

    \[\begin{align} + \dot{\sigma}_{p} &= p_\text{ref} - p_m \tag{4a} \\ + \dot{p}_m &= \omega_z (p_e - p_m) \tag{4b} \\ + \dot{\sigma}_{q} &= q_\text{ref} - q_m \tag{4c} \\ + \dot{q}_m &= \omega_f (q_e - p_m) \tag{4d} \\ +\end{align}\]

    with

    \[\begin{align} + p_e &= v_ri_r + v_ii_i \tag{4e} \\ + q_e &= v_ii_r - v_ri_i \tag{4f} \\ + \omega_{\text{olc}} &= \omega_{\text{pll}} \tag{4g} \\ + \theta_{\text{olc}} &= \theta_{\text{pll}} \tag{4h} \\ + i_\text{d,cv}^\text{ref} &= k_p^q (q_\text{ref} - q_m) + k_i^q \sigma_q \tag{4i} \\ + i_\text{q,cv}^\text{ref} &= k_p^p (p_\text{ref} - p_m) + k_i^p \sigma_p \tag{4j} \\ +\end{align}\]

    This models requires a PLL to have a SRF for an internal $dq$ reference frame. Contrary to the Grid-Forming model, it cannot work without a PLL. Since this Outer Control outputs a current reference, it can only be used with a current mode inner control (i.e. that receives a current reference instead of a voltage reference).

    Active and Reactive Generic Renewable Controller Type AB [OuterControl]

    The following model represents an outer controller for both active and reactive power from generic industrial models REPCA and REECB to generate the current references that will be used in the Current Controller of the inner control RECurrentControlB. The constructor is OuterControl{ActiveRenewableControllerAB, ReactiveRenewableControllerAB}. The equations will depend on the flags used.

    Active part

    In the case of F_Flag = 1 the equations (without limits and freezing) are:

    \[\begin{align} + \dot{p}_{\text{flt}} &= \frac{1}{T_p} (p_e - p_{\text{flt}}) \tag{5a} \\ + \dot{\xi}_{P} &= p_{\text{err}} \tag{5b} \\ + \dot{p}_{\text{ext}} &= \frac{1}{T_g} (K_{pg} p_{\text{err}} + K_{ig} \xi_P) \tag{5c} \\ + \dot{p}_{\text{ord}} &= \frac{1}{T_{\text{pord}}} (p_{\text{ext}} - p_{\text{ord}}) \tag{5d} +\end{align}\]

    with

    \[\begin{align} + p_e &= v_ri_r + v_ii_i \tag{5e} \\ + p_\text{err} &= p_\text{ref} + p_\text{droop} - p_\text{flt} \tag{5f} +\end{align}\]

    In the case of F_Flag = 0 the equations (without limits) are simply

    \[\begin{align} + \dot{p}_{\text{ord}} &= \frac{1}{T_{\text{pord}}} (p_{\text{ref}} - p_{\text{ord}}) \tag{5g} +\end{align}\]

    The current command going to the Inner Loop is computed as:

    \[\begin{align} + I_{\text{oc,pcmd}} &= \frac{p_{\text{ord}}}{V_{\text{t,flt}}} \tag{5h} +\end{align}\]

    on which $V_\text{t,flt}$ is the filtered terminal bus voltage coming from the inner controller.

    Reactive part

    In the case of VC_Flag = 0, Ref_Flag = 0, PF_Flag = 0, V_Flag = 1 the equations (without limits and freezing) are:

    \[\begin{align} + \dot{q}_\text{flt} &= \frac{1}{T_\text{fltr}} (q_e - q_\text{flt}) \tag{5i} \\ + \dot{\xi}_\text{q,oc} &= q_\text{err} \tag{5j} \\ + \dot{q}_{LL} &= \frac{1}{T_{fv}}(Q_\text{pi} ( 1 - T_{ft}/T_{fv}) - q_{LL}) \tag{5k} \\ + \dot{\xi}_Q &= V_\text{pi,in} \tag{5l} +\end{align}\]

    with

    \[\begin{align} + q_e &= v_ii_r - v_ri_i \tag{5m} \\ + q_\text{err} &= q_\text{ref} - q_flt \tag{5n} \\ + Q_\text{pi} &= K_p q_\text{err} + K_i \xi_\text{q,oc} \tag{5o} \\ + Q_\text{ext} &= q_{LL} + \frac{T_{ft}}{T_{fv}} Q_\text{pi} \tag{5p} \\ + V_\text{pi,in} &= Q_\text{ext} - q_e \tag{5q} +\end{align}\]

    The output to the inner controller are $V_\text{oc,qcmd}$ if the Q_Flag = 1 on the Inner Controller, or $I_\text{oc,qcmd}$ if Q_Flag = 0:

    \[\begin{align} + V_\text{oc,qcmd} &= (K_{qp} V_\text{pi,in} + K_{qi} \xi_Q) - V_\text{t,flt} \tag{5r} \\ + I_\text{oc,qmcd} &= \frac{Q_\text{ext}}{\max(V_\text{t,flt}, 0.01)} \tag{5s} +\end{align}\]

    In the case of VC_Flag = 0, Ref_Flag = 0, PF_Flag = 0, V_Flag = 1 the equations (without limits and freezing) are:

    \[\begin{align} + \dot{q}_\text{flt} &= \frac{1}{T_\text{fltr}} (q_e - q_\text{flt}) \tag{5t} \\ + \dot{\xi}_\text{q,oc} &= q_\text{err} \tag{5u} \\ + \dot{q}_{LL} &= \frac{1}{T_{fv}}(Q_\text{pi} ( 1 - T_{ft}/T_{fv}) - q_{LL}) \tag{5v} \\ +\end{align}\]

    The remaining models for other flags will be included when implemented in PowerSimulationsDynamics.jl.

    diff --git a/previews/PR360/component_models/pss/index.html b/previews/PR360/component_models/pss/index.html new file mode 100644 index 000000000..9fb4a340a --- /dev/null +++ b/previews/PR360/component_models/pss/index.html @@ -0,0 +1,26 @@ + +PSS · PowerSimulationsDynamics.jl

    Power System Stabilizers (PSS)

    PSS are used to add an additional signal $v_s$ to the input signal of the AVR: $v_\text{ref} = v_\text{ref}^{\text{avr}} + v_s$.

    Fixed PSS [PSSFixed]

    This is a simple model that set the stabilization signal to be equal to a desired constant value $v_s = v_{s}^{\text{fix}}$. The absence of PSS can be modelled using this component with $v_s^{\text{fix}} = 0$.

    Simple PSS [PSSSimple]

    This is the most basic PSS that can be implemented, on which the stabilization signal is a proportional controller over the frequency and electrical power:

    \[\begin{align} +v_s = K_{\omega}(\omega - \omega_s) + K_p(\omega \tau_e - P_{\text{ref}}) \tag{1a} +\end{align}\]

    IEEE Stabilizer [IEEEST]

    The 7th-order PSS model is:

    \[\begin{align} +A_4 \dot{x}_1 &= u - A_3 x_1 - x_2 \tag{2a} \\ +\dot{x}_2 &= x_1 \tag{2b} \\ +A_2\dot{x}_3 &= x_2 - A_1 x_3 - x_4 \tag{2c}\\ +\dot{x}_4 &= x_3 \tag{2d}\\ +T_2\dot{x}_5 &= \left(1 - \frac{T_1}{T_2}\right) y_f - x_5 \tag{2e}\\ +T_4\dot{x}_6 &= \left(1 - \frac{T_3}{T_4}\right) y_{LL1} - x_6 \tag{2f}\\ +T_6\dot{x}_7 &= -\left(\frac{K_s T_5}{T_6} y_{LL2} + x_7 \right) \tag{2g} +\end{align}\]

    with

    \[\begin{align*} +y_f &= \frac{T_4}{T_2} x_2 + \left(T_3 - T_1 \frac{T_4}{T_2}\right) x_3 + \left(1 - \frac{T_4}{T_2}\right)x_4 \\ +y_{LL1} &= x_5 + \frac{T_1}{T_2} y_f \\ +y_{LL2} &= x_6 + \frac{T_3}{T_4} y_{LL1} \\ +y_{out} &= x_7 + \frac{K_s T_5}{T_6} y_{LL2} \\ +V_s &= \text{clamp}(y_{out}, \text{Ls}_\text{min}, \text{Ls}_\text{max}) +\end{align*}\]

    on which $u$ is the input signal to the PSS, that depends on the flag. Currently, rotor speed, electric torque, mechanical torque and voltage magnitude are supported inputs.

    STAB1 PSS [STAB1]

    The 3rd-order PSS model is:

    \[\begin{align} +T \dot{x}_1 &= K \omega - x_1 \tag{3a} \\ +T_3\dot{x}_2 &= \left(1 - \frac{T_1}{T_3}\right) x_1 - x_2 \tag{3b} \\ +T_4\dot{x}_3 &= \left(1 - \frac{T_2}{T_4}\right) y_{LL} - x_2 \tag{3c} \\ +\end{align}\]

    with

    \[\begin{align*} +y_{LL} = x_2 + \frac{T_1}{T_3} x_1 \\ +y_{out} = x_3 + \frac{T_2}{T_4} y_{LL} \\ +V_s = \text{clamp}(y_{out}, -H_{lim}, H_{lim}) +\end{align*}\]

    diff --git a/previews/PR360/component_models/shafts/index.html b/previews/PR360/component_models/shafts/index.html new file mode 100644 index 000000000..12835dee4 --- /dev/null +++ b/previews/PR360/component_models/shafts/index.html @@ -0,0 +1,16 @@ + +Shaft · PowerSimulationsDynamics.jl

    Shafts

    The shaft component defines the rotating mass of the synchronous generator.

    Rotor Mass Shaft [SingleMass]

    This is the standard model, on which one single mass (typically the rotor) is used to model the entire inertia of the synchronous generator. Each generator's rotating frame use a reference frequency $\omega_s$, that typically is the synchronous one (i.e. $\omega_s = 1.0$). The model defines two differential equations for the rotor angle $\delta$ and the rotor speed $\omega$:

    \[\begin{align} +\dot{\delta} &= \Omega_b(\omega - \omega_s) \tag{1a} \\ +\dot{\omega} &= \frac{1}{2H}(\tau_m - \tau_e - D(\omega-\omega_s)) \tag{1b} +\end{align}\]

    Five-Mass Shaft [FiveMassShaft]

    This model describes model connecting a high-pressure (hp) steam turbine, intermediate-pressure (ip) steam turbine, low-pressure (lp) steam pressure, rotor and exciter (ex) connected in series (in that order) in the same shaft using a spring-mass model:

    \[\begin{align} +\dot{\delta} &= \Omega_b(\omega - \omega_s) \tag{2a} \\ +\dot{\omega} &= \frac{1}{2H} \left[- \tau_e - D(\omega-\omega_s)) - D_{34} (\omega-\omega_{lp}) - D_{45}(\omega-\omega_{ex}) + K_{lp}(\delta_{lp-\delta}) +K_{ex}(\delta_{ex}-\delta) \right] \tag{2b} \\ +\dot{\delta}_{hp} &= \Omega_b(\omega_{hp} - \omega_s) \tag{2c} \\ +\dot{\omega}_{hp} &= \frac{1}{2H_{hp}} \left[ \tau_m - D_{hp}(\omega_{hp}-\omega_s) - D_{12}(\omega_{hp} - \omega_{ip}) + K_{hp}(\delta_{ip} - \delta_{hp}) \right] \tag{2d} \\ +\dot{\delta}_{ip} &= \Omega_b(\omega_{ip} - \omega_s) \tag{2e} \\ +\dot{\omega}_{ip} &= \frac{1}{2H_{ip}} \left[- D_{ip}(\omega_{ip}-\omega_s) - D_{12}(\omega_{ip} - \omega_{hp}) -D_{23}(\omega_{ip} - \omega_{lp} ) + K_{hp}(\delta_{hp} - \delta_{ip}) + K_{ip}(\delta_{lp}-\delta_{ip}) \right] \tag{2f} \\ +\dot{\delta}_{lp} &= \Omega_b(\omega_{lp}-\omega_s) \tag{2g} \\ +\dot{\omega}_{lp} &= \frac{1}{2H_{lp}} \left[ - D_{lp}(\omega_{lp}-\omega_s) - D_{23}(\omega_{lp} - \omega_{ip}) -D_{34}(\omega_{lp} - \omega ) + K_{ip}(\delta_{ip} - \delta_{lp}) + K_{lp}(\delta-\delta_{lp}) \right] \tag{2h} \\ +\dot{\delta}_{ex} &= \Omega_b(\omega_{ex}-\omega_s) \tag{2i} \\ +\dot{\omega}_{ex} &= \frac{1}{2H_{ex}} \left[ - D_{ex}(\omega_{ex}-\omega_s) - D_{45}(\omega_{ex} - \omega) + K_{ex}(\delta - \delta_{ex}) \right] \tag{2j} +\end{align}\]

    diff --git a/previews/PR360/component_models/turbine_gov/index.html b/previews/PR360/component_models/turbine_gov/index.html new file mode 100644 index 000000000..3780f85b6 --- /dev/null +++ b/previews/PR360/component_models/turbine_gov/index.html @@ -0,0 +1,45 @@ + +Turbine and Governor · PowerSimulationsDynamics.jl

    Prime Movers and Turbine Governors (TG)

    This section describes how mechanical power is modified to provide primary frequency control with synchronous generators. It is assumed that $\tau_{\text{ref}} = P_{\text{ref}}$ since they are decided at nominal frequency $\omega = 1$.

    Fixed TG [TGFixed]

    This a simple model that set the mechanical torque to be equal to a proportion of the desired reference $\tau_m = \eta P_{\text{ref}}$. To set the mechanical torque to be equal to the desired power, the value of $\eta$ is set to 1.

    TG Type I [TGTypeI]

    This turbine governor is described by a droop controller and a low-pass filter to model the governor and two lead-lag blocks to model the servo and reheat of the turbine governor.

    \[\begin{align} +\dot{x}_{g1} &= \frac{1}{T_s}(p_{\text{in}} - x_{g1}) \tag{1a} \\ +\dot{x}_{g2} &= \frac{1}{T_c} \left[ \left(1- \frac{t_3}{T_c}\right)x_{g1} - x_{g2} \right] \tag{1b} \\ +\dot{x}_{g3} &= \frac{1}{T_5} \left[\left(1 - \frac{T_4}{T_5}\right)\left(x_{g2} + \frac{T_3}{T_c}x_{g1}\right) - x_{g3} \right] \tag{1c} \\ +\tau_m &= x_{g3} + \frac{T_4}{T_5}\left(x_{g2} + \frac{T_3}{T_c}x_{g1}\right) \tag{1d} +\end{align}\]

    with

    \[\begin{align*} +p_{\text{in}} = P_{\text{ref}} + \frac{1}{R}(\omega_s - 1.0) +\end{align*}\]

    TG Type II [TGTypeII]

    This turbine governor is a simplified model of the Type I.

    \[\begin{align} +\dot{x}_g &= \frac{1}{T_2}\left[\frac{1}{R}\left(1 - \frac{T_1}{T_2}\right) (\omega_s - \omega) - x_g\right] \tag{2a} \\ +\tau_m &= P_{\text{ref}} + \frac{1}{R}\frac{T_1}{T_2}(\omega_s - \omega) \tag{2b} +\end{align}\]

    TGOV1 [SteamTurbineGov1]

    This represents a classical Steam-Turbine Governor, known as TGOV1.

    \[\begin{align} +\dot{x}_{g1} &= \frac{1}{T_1} (\text{ref}_{in} - x_{g1}) \tag{3a} \\ +\dot{x}_{g2} &= \frac{1}{T_3} \left(x_{g1}^\text{sat} \left(1 - \frac{T_2}{T_3}\right) - x_{g2}\right) \tag{3b} +\end{align}\]

    with

    \[\begin{align} +\text{ref}_{in} &= \frac{1}{R} (P_{ref} - (\omega - 1.0)) \tag{3c} \\ +x_{g1}^\text{sat} &= \left\{ \begin{array}{cl} + x_{g1} & \text{ if } V_{min} \le x_{g1} \le V_{max}\\ + V_{max} & \text{ if } x_{g1} > V_{max} \\ + V_{min} & \text{ if } x_{g1} < V_{min} + \end{array} \right. \tag{3d} \\ +\tau_m &= x_{g2} + \frac{T_2}{T_3} x_{g1} - D_T(\omega - 1.0) \tag{3e} +\end{align}\]

    GAST [GasTG]

    This turbine governor represents the Gas Turbine representation, known as GAST.

    \[\begin{align} +\dot{x}_{g1} &= \frac{1}{T_1} (x_{in} - x_{g1}) \tag{4a} \\ +\dot{x}_{g2} &= \frac{1}{T_2} \left(x_{g1}^\text{sat} - x_{g2}\right) \tag{4b} \\ +\dot{x}_{g3} &= \frac{1}{T_3} (x_{g2} - x_{g3}) \tag{4c} +\end{align}\]

    with

    \[\begin{align} +x_{in} &= \min\left\{P_{ref} - \frac{1}{R}(\omega - 1.0), A_T + K_T (A_T - x_{g3}) \right\} \tag{4d} \\ +x_{g1}^\text{sat} &= \left\{ \begin{array}{cl} + x_{g1} & \text{ if } V_{min} \le x_{g1} \le V_{max}\\ + V_{max} & \text{ if } x_{g1} > V_{max} \\ + V_{min} & \text{ if } x_{g1} < V_{min} + \end{array} \right. \tag{4e} \\ +\tau_m &= x_{g2} - D_T(\omega - 1.0) \tag{4f} +\end{align}\]

    HYGOV [HydroTurbineGov]

    This represents a classical hydro governor, known as HYGOV.

    \[\begin{align} +T_f\dot{x}_{g1} &= P_{in} - x_{g1} \tag{5a} \\ +\dot{x}_{g2} &= x_{g1} \tag{5b}\\ +T_g \dot{x}_{g3} &= c - x_{g3} \tag{5c}\\ +\dot{x}_{g4} &= \frac{1 - h}{T_w} \tag{5d} +\end{align}\]

    with

    \[\begin{align} +P_{in} &= P_{ref} - \Delta \omega - R x_{g2} \tag{5e} \\ +c &= \frac{x_{g1}}{r} + \frac{x_{g2}}{rT_r} \tag{5f} \\ +h &= \left(\frac{x_{g4}}{x_{g3}}\right)^2 \tag{5g}\\ +\tau_m &= h\cdot A_t(x_{g4} - q_{NL}) - D_{turb} \Delta\omega \cdot x_{g3} \tag{5h} +\end{align}\]

    diff --git a/previews/PR360/execute/index.html b/previews/PR360/execute/index.html new file mode 100644 index 000000000..a761998aa --- /dev/null +++ b/previews/PR360/execute/index.html @@ -0,0 +1,18 @@ + +Simulation Execution · PowerSimulationsDynamics.jl

    Executing a Simulation

    After constructing the System data from PowerSystems.jl with its dynamic components, a Simulation structure must be constructed. Check the API for Simulation and Simulation! for its construction and available arguments.

    Once a Simulation is constructed and properly initialized, the execute! command is used to run the Simulation. If no perturbation was included, then a steady state simulation will be run over the time span defined. See the API of execute! for more details.

    Solvers

    Solvers must be chosen accordingly depending on the type of model used in the Simulation. For example, a Residual model can be executed using Sundials IDA solver:

    using Sundials
    +sim = Simulation(
    +    ResidualModel,
    +    sys,
    +    pwd(),
    +    (0.0, 20.0),
    +    perturbation,
    +)
    +execute!(sim, IDA())

    Results can be explored using:

    results = read_results(sim)

    Similarly, a Mass Matrix model can be executed using Rodas4 solver.

    using OrdinaryDiffEq
    +sim2 = Simulation(
    +    MassMatrixModel,
    +    sys,
    +    pwd(),
    +    (0.0, 20.0),
    +    perturbation,
    +)
    +execute!(sim2, Rodas4())

    Exploring the Solution

    Once a Simulation is executed and the results are stored via results = read_results(sim), the following functions can be used to explore the Simulation solution:

    Show initial conditions

    The function show_states_initial_value(results) can be used to display the initial condition of the voltages and dynamic states of each dynamic component.

    Explore bus voltages

    The function get_voltage_magnitude_series(results, BusNumber) can be used to obtain the voltage magnitude time series of the specified bus. Similarly, get_voltage_angle_series(results, BusNumber) can be used to obtain the voltage angle time series of the specified bus.

    Explore output currents

    The functions get_real_current_series(results, "DeviceName") and get_imaginary_current_series(results, "DeviceName") can be used to obtain the output current time series of the specified device.

    Explore output power

    The functions get_activepower_series(results, "DeviceName") and get_reactivepower_series(results, "DeviceName") can be used to obtain the output power time series of the specified device.

    Explore dynamic states

    The function get_state_series(results, ("DeviceName", :StateSymbol) can be used to obtain the specified state time series of the specified device.

    Explore Reference Setpoints

    The function get_setpoints(sim) can be used to obtain the reference setpoints of each dynamic device. Note: If a setpoint was changed via a perturbation, this function will return the modified setpoint.

    Keyword Arguments

    Any solver option available in DifferentialEquations.jl can be passed as keyword arguments in the execute! function. Please see the Common Solver Options in the DifferentialEquations.jl documentation for more details.

    Most common solver options used are dtmax to control the maximum dt for adaptive timestepping. abstol and reltol are also commonly used to control the tolerance in the adaptive timestepping. saveat is also used to store the results at a specified time stamps. For example, the following code is valid to further specify your solver options:

    execute!(sim, IDA(), dtmax = 0.01, abstol = 1e-9, reltol = 1e-6, saveat = 0.01)

    In addition, the keyword argument enable_progress_bar = false can be used to disable the progress bar.

    diff --git a/previews/PR360/generic/index.html b/previews/PR360/generic/index.html new file mode 100644 index 000000000..589d0abab --- /dev/null +++ b/previews/PR360/generic/index.html @@ -0,0 +1,2 @@ + +Industrial Renewable Models · PowerSimulationsDynamics.jl

    Industrial (Generic) Renewable Models

    Connection with the Inverter Metamodel

    Generic Renewable Models for PV solar or battery devices used in industrial tools, such as PSS/E or PowerWorld, does not necessary resemble the proposed structure of our proposed metamodel.

    In general terms, a generic renewable model (for PV plant or battery) is typically a Grid Following inverter that uses a Renewable Energy Plant Controller (REPC), a Renewable Energy Electrical Controller (REEC) and a Renewable Energy Generic Converter (REGC) model. The following figure is useful to understand the general structure of such models:

    In comparison to the proposed inverter metamodel it is clear that the REPC resembles the Outer Control. However, the REEC has a purpose of both Outer Control and Inner Control and the REGC has a similar purpose of the Converter and Filter in the proposed structure. For such purpose, it was necessary to split the REEC and part of its model was included in both Outer Control and Inner Control.

    Example of implementation of generic models

    The following includes examples of the implementation of the proposed model in the inverter metamodel.

    Active Renewable Outer Control

    The following example join the active power controllers from REPCA and REECB as ActiveRenewableControllerAB in PowerSimulationsDynamics.jl

    An important thing to consider with the industrial models, is that the change of Flags can significantly vary the model and purpose of the controller.

    Reactive Renewable Outer Control

    Similar to the active controller, the following figure presents the reactive controller part from REPCA and REECB as ReactiveRenewableControllerAB in PowerSimulationsDynamics.jl

    Inner Controller

    Finally, the remaining part from REECB was included RECurrentControllerB

    The REGCAmodel was directly included in a Converter Block, and the filter can be bypassed using an RLFilter block with rf = lf = 0.

    Current availability of model flags in PSID

    Active Controller

    For the active controller, both Freq_Flag = 0 (ignoring frequency regulation) and Freq_Flag = 1 (considering frequency regulation) are available.

    Reactive Controller

    The following table describes the current available combination of flags in PSID:

    REF_FlagPF_FlagV_FlagQ_Flag
    0000
    0010
    1011
    1000

    Any combination outside of these cases may not converge to a feasible operating point. Check the following CAISO report for the description and compliance of each flag combination.

    diff --git a/previews/PR360/index.html b/previews/PR360/index.html new file mode 100644 index 000000000..6b0eb4c3b --- /dev/null +++ b/previews/PR360/index.html @@ -0,0 +1,7 @@ + +Welcome Page · PowerSimulationsDynamics.jl

    PowerSimulationsDynamics.jl

    Overview

    PowerSimulationsDynamics.jl is a Julia package for doing Power Systems Dynamic Modeling with Low Inertia Energy Sources.

    The synchronous machine components supported here are based on commercial models and the academic components are derived from Power System Modelling and Scripting.

    Inverter models support both commercial models, such as REPC, REEC and REGC type of models; and academic models obtained from grid-following and grid-forming literature such as in "A Virtual Synchronous Machine implementation for distributed control of power converters in SmartGrids"

    The background work on PowerSimulationsDynamics.jl is explained in Revisiting Power Systems Time-domain Simulation Methods and Models

    @article{lara2023revisiting,
    +title={Revisiting Power Systems Time-domain Simulation Methods and Models},
    +author={Lara, Jose Daniel and Henriquez-Auba, Rodrigo and Ramasubramanian, Deepak and Dhople, Sairaj and Callaway, Duncan S and Sanders, Seth},
    +journal={arXiv preprint arXiv:2301.10043},
    +year={2023}
    +}

    Installation

    The latest stable release of PowerSimulationsDynamics.jl can be installed using the Julia package manager with

    ] add PowerSimulationsDynamics

    For the current development version, "checkout" this package with

    ] add PowerSimulationsDynamics#master

    Structure

    The following figure shows the interactions between PowerSimulationsDynamics.jl, PowerSystems.jl, ForwardDiff.jl, DiffEqBase.jl and the integrators. The architecture of PowerSimulationsDynamics.jl is such that the power system models are all self-contained and return the model function evaluations. The Jacobian is calculated using automatic differentiation through ForwardDiff.jl, that is used for both numerical integration and small signal analysis. Considering that the resulting models are differential-algebraic equations (DAE), the implementation focuses on the use of implicit solvers, in particular BDF and Rosenbrock methods.


    PowerSimulationsDynamics.jl has been developed as part of the Scalable Integrated Infrastructure Planning (SIIP) initiative at the U.S. Department of Energy's National Renewable Energy Laboratory (NREL)

    diff --git a/previews/PR360/initialization/index.html b/previews/PR360/initialization/index.html new file mode 100644 index 000000000..be5417528 --- /dev/null +++ b/previews/PR360/initialization/index.html @@ -0,0 +1,23 @@ + +Initialization · PowerSimulationsDynamics.jl

    Initialization Routine

    Dynamic Simulations require a reasonable initial condition for the system model. In most analysis, power systems models are initialized at a stable equilibrium, which implies that:

    \[\begin{align} +0 = F(x, u, \eta) +\end{align}\]

    Finding the solution of a large non-linear system is challenging and requires a reasonable initial guess. In classical power systems literature, the routine to find equilibrium points for the dynamic injection devices' components is well known and used in free and commercial software (see Power System Modelling and Scripting page 224). However, in the case of converter interface dynamic injection models, such routines are not documented.

    Initializing the system also requires finding valid set-points for the devices in the system. For instance, finding the reference voltage in an AVR to match the voltage magnitude resulting from the power flow solution. PowerSimulationsDynamics.jl prioritizes mathching the dynamic components control references to match the power flow results.

    Finally, the initialization must instantiate not only the values of the states but also the inner vars. PowerSimulationsDynamics.jl handles all this initializations by default.

    Initialization interface

    By default PowerSimulationsDynamics.jl initializes the system following the steps described below. it is possible to provide an initial guess for the initial conditions to speed up the initialization process.

    Simulation(
    +        ResidualModel,
    +        sys,
    +        pwd(),
    +        (0.0, 20.0);
    +        initial_conditions = x0_init,
    +    )

    It is also possible to initialize the simulation using a flat start (V_mag = 1.0, V_angle = 0.0 and x0 = zeros) using initialize_simulation = false. However, for medium or large system this is unlikely to result in a valid initial condition for the simulation.

    Simulation(
    +        ResidualModel,
    +        sys,
    +        pwd(),
    +        (0.0, 20.0);
    +        initialize_simulation = false,
    +    )

    If you want to avoid PowerSimulationsDynamics.jl from finding an stable equilibrium automatically and provide the initial condition manually you can use the following flag combination.

    Simulation(
    +        ResidualModel,
    +        sys,
    +        pwd(),
    +        (0.0, 20.0);
    +        initialize_simulation = false,
    +        initial_conditions = x0_init,
    +    )

    <span style="color:red">WARNING!</span>: when the initialize_simulation is set to false, neither the device set points nor the inner vars are initialized. Use these keywords with care and make sure the values in the system components match the initial conditions provided.

    System-wide initialization routine

    The initialization routine starts from the solution of the power flow equations. For each dynamic injection device PowerSimulationsDynamics.jl finds the solution of the systems of non-linear equations for each dynamic component following the sequences described in the forthcoming sections.

    Once each device is individually initialized, the system-wide initial guess is used to solve the system (1). In a first attempt at finding the solution, the tolerance is set to a stringent tolerance. If the non-linear solver is unable to get a solution, it might usually reflect small signal stability problems in the system. In a second attempt, the tolerances are relaxed. If the solver succeeds, the simulation continues, but the user is warned.

    Initialization of the Synchronous Machines

    The initialization of Synchronous Machines is standard in power systems and follows the scheme shown in the figure. Other internal variables are calculated recursively from the power flow solution for the node on which the dynamic device isconnected. (Adapted from Power System Modelling and Scripting Figure 9.2)

    init_machine

    Initialization of the Inverters

    Initializing the inverters follows the sequence shown in the figure and has been developed to be compatible with the implementation of custom dynamic components. Given that the process is less studied and standard than the one of the synchronous machine, this page contains more detailed documentation of the process.

    init_machine

    1. The first component to be initialized is the filter. Given that the filter is an RLC circuit connected to the grid, its currents and voltages need to match the results of the power flow. The initialization of the filter provides the values for the $P$ and $Q$ used in the outer control and the $V$ and $I$ needed in the inner controls.
    2. Based on the bus voltage in the system's reference frame $V_r$ and the bus angle $\theta$ the PLL's can be initialized to obtain the angle and frequency estimates needed by the outer control.
    3. The Outer Control calculates the internal angle $\delta_{olc}$ required by the inner control to estimate the voltage and current phase difference.
    4. The DC Source uses the power set-point consistent with the power outputs of the filter to initialize the $V_{dc}$ set-points. This value is used in the inner control.
    5. The inner control takes the phase angle $\delta_{olc}$ and the $V_{dc}$ to estimate the modulation values of the PWM converter.

    Note: The initialization of an inverter through the proposed meta-model is actively under development and subject to change. This page will maintain the latest version of the sequence.

    diff --git a/previews/PR360/models/index.html b/previews/PR360/models/index.html new file mode 100644 index 000000000..efe248ce2 --- /dev/null +++ b/previews/PR360/models/index.html @@ -0,0 +1,8 @@ + +Models · PowerSimulationsDynamics.jl

    Models

    Simulation Models

    PowerSimulations dynamics supports two formulations for the simulation model and define different methods for each simulation model. You can pass ResidualModel or MassMatrixModel to a call to Simulation to define the preferred formulation.

    In this way, we provide a common set of development requirements for contributors of new models that maintains the same flexibility in choosing the solving algorithm.

    • MassMatrixModel: Defines models that can be solved using Mass-Matrix Solvers. The model is formulated as follows:

    \[\begin{align} +M\frac{dx(t)}{dt} = f(x(t)) +\end{align}\]

    At this stage we have not conducted extensive tests with all the solvers in DifferentialEquations most of our tests use Rodas5().

    • ResidualModel: Define models that can be solved using Implicit ODE solvers and also the solver IDA from Sundials. The model is formulated to solved the following problem:

    \[\begin{align} +r(t) = \frac{dx(t)}{dt} - f(x(t)) +\end{align}\]

    At this stage we have not conducted extensive tests with all the solvers in DifferentialEquations if you are solving a larger system use IDA().

    The dynamic system model in PowerSimulationsDynamics

    In order to support both formulations, the default implementation of the ResidualModel solves the following problem:

    \[\begin{align} +r(t) = M\frac{dx(t)}{dt} - f(x(t)) +\end{align}\]

    Solution approaches

    PowerSimulationsDynamics.jl construct the entire function that is passed to DifferentialEquations to solve it using different solvers. This is called the Simultaneous-solution approach to numerically integrate over time. It gives the user the flexibility to model devices with a combination of differential and algebraic states. In addition, it gives the flexibility to model the network using an algebraic or differential model.

    On the other hand, industrial tools such as PSS/E uses a Partitioned-solution approach, on which the network must be modeled using an algebraic approach, and the differential equations and algebraic equations are solved sequentially. This method is usually faster if the heuristics for convergence when solving sequentially are properly tuned. However, boundary techniques must be considered when the connection with the devices and network is not converging when applying the partitioned-solution approach.

    The difference in solution methods can complicate the validation and comparison between software tools. In addition it can affect the computational properties due to reliance of heuristics. These solution aspects are important to consider when using different tools for simulating power systems dynamics.

    For more details, check Brian Stott paper "Power system dynamic response calculations".

    Generator Models

    Here we discuss the structure and models used to model generators in PowerSimulationsDynamics.jl. See PowerSystems.jl dynamic devices for details.

    Each generator is a data structure composed of the following components defined in PowerSystems.jl:

    The implementation of Synchronous generators as components uses the following structure to share values across components.

    Inverter Models

    Here we discuss the structure and models used to model inverters in PowerSimulationsDynamics.jl. See PowerSystems.jl dynamic devices for details. One of the key contributions in this software package is a separation of the components in a way that resembles current practices for synchronoues machine modeling.

    • DC Source: Defines the dynamics of the DC side of the converter.
    • Frequency Estimator: That describes how the frequency of the grid can be estimated using the grid voltages. Typically a phase-locked loop (PLL).
    • Outer Loop Control: That describes the active and reactive power control dynamics.
    • Inner Loop Control: That can describe virtual impedance, voltage control and current control dynamics.
    • Converter: That describes the dynamics of the pulse width modulation (PWM) or space vector modulation (SVM).
    • Filter: Used to connect the converter output to the grid.

    The following figure summarizes the components of a inverter and which variables they share:

    Contrary to the generator, there are many control structures that can be used to model inverter controllers (e.g. grid-following, grid feeding or virtual synchronous machine). For this purpose, more variables are shared among the components in order to cover all these posibilities.

    Reference

    For models, check the library in PowerSystems.jl

    diff --git a/previews/PR360/perturbations/index.html b/previews/PR360/perturbations/index.html new file mode 100644 index 000000000..335655201 --- /dev/null +++ b/previews/PR360/perturbations/index.html @@ -0,0 +1,44 @@ + +Perturbations · PowerSimulationsDynamics.jl

    Perturbations

    Perturbations are used to alter the system from its steady state operation. If a Simulation is properly initialized, all states will remain fixed in their initial condition if no perturbation is applied to the system.

    List of perturbations

    • NetworkSwitch: allows to modify directly the admittance matrix, Ybus, used in the Simulation.
    • BranchTrip: completely disconnects a branch from the system.
    • BranchImpedanceChange: change the impedance of a branch by a user defined multiplier.
    • GeneratorTrip: allows to disconnect a Dynamic Generation unit from the system.
    • ControlReferenceChange: allows to change the reference setpoint provided by a generator/inverter.
    • LoadChange: allows to change the active or reactive power setpoint from a load.
    • LoadTrip: allows the user to disconnect a load from the system.
    • SourceBusVoltageChange: allows to change the reference setpoint provided by a voltage source.

    Examples

    Example 1: Circuit Disconnection using NetworkSwitch

    Consider a two bus system connected via a double circuit line, on which each circuit has parameters, r = 0.0, x = 0.1, b = 0.0 per unit, then the admittance matrix of the original system is given by:

    yb = [0.0 - 20.0im 0.0 + 20.0im
    +      0.0 + 20.0im 0.0 - 20.0im]

    Triping one circuit can be modeled by doubling the impedance, i.e., dividing by 2 the admittance:

    new_yb = [0.0 - 10.0im 0.0 + 10.0im
    +          0.0 + 10.0im 0.0 - 10.0im]

    To apply a Network Switch, we require to use a sparse matrix, so we can do this by simply:

    using SparseArrays
    +new_yb = sparse(new_yb)

    Then, this perturbation ocurring at $t = 1.0$ seconds can be included as:

    ns1 = NetworkSwitch(1.0, new_yb)

    Example 2: Three Phase Fault using NetworkSwitch

    Another perturbation that can be modeled is a three phase fault at Bus 1 with impedance r_f = 0.0001, x_f = 0.0 per unit, then the admittance of this new system is:

    new_yb2 = [10000.0 - 20.0im  0.0 + 20.0im
    +           0.0 + 20.0im  0.0 - 20.0im]

    Then, this perturbation ocurring at $t = 1.0$ seconds can be included as:

    new_yb2 = sparse(new_yb2)
    +ns2 = NetworkSwitch(1.0, new_yb2)

    Now, consider that the fault is cleared at $t = 1.05$ seconds by disconnecting the Circuit 2 of the line. This can be modeled with the single circuit admittance matrix:

    new_yb3 = [0.0 - 10.0im 0.0 + 10.0im
    +           0.0 + 10.0im 0.0 - 10.0im]

    and the perturbation as:

    new_yb3 = sparse(new_yb3)
    +ns3 = NetworkSwitch(1.05, new_yb3)

    Then, the entire perturbation for the Simulation can be included in a vector of perturbations as:

    three_fault = [ns2, ns3]

    that can be passed as a perturbation argument in the Simulation construction.

    Example 3: BranchTrip

    Consider the following 2 bus system defined by:

    buses = [
    +    Bus(1, "nodeA", "REF", 0, 1.0, (min = 0.9, max = 1.05), 230, nothing, nothing),
    +    Bus(2, "nodeB", "PV", 0, 1.0, (min = 0.9, max = 1.05), 230, nothing, nothing),
    +]
    +
    +line1 = Line(
    +        "Circuit1",
    +        true,
    +        0.0,
    +        0.0,
    +        Arc(from = buses[1], to = buses[2]),
    +        0.00,
    +        0.1,
    +        (from = 0.0, to = 0.0),
    +        2.0,
    +        (min = -0.7, max = 0.7),
    +    )
    +line2 = Line(
    +        "Circuit2",
    +        true,
    +        0.0,
    +        0.0,
    +        Arc(from = buses[1], to = buses[2]),
    +        0.0,
    +        0.1,
    +        (from = 0.0, to = 0.0),
    +        2.0,
    +        (min = -0.7, max = 0.7),
    +    )
    +
    +sys = System(100.0, buses, [], [], [line1, line2])

    A Branch Trip of Circuit 2 at time $t = 1.0$ seconds, can be implemented as:

    b_trip = BranchTrip(1.0, Line, "Circuit2")

    Note: Islanding is currently not supported in PowerSimulationsDynamics.jl. If a BranchTrip isolates a generation unit, the system may diverge due to the isolated generator.

    Example 4: BranchImpedanceChange

    Following the same example as before, it is possible to amplify the impedance of a single circuit by 2.0 (that would represent that this Circuit is actually composed by 2 circuits) using the following perturbation:

    b_change = BranchImpedanceChange(1.0, Line, "Circuit2", 2.0)

    Example 5: GeneratorTrip

    Consider that you have a generator at bus 102, named "generator-102-1" in your system called sys. The constructor to trip it from the system is:

    g = get_component(DynamicGenerator, sys, "generator-102-1")
    +g_trip = GeneratorTrip(1.0, g)

    Example 6: ControlReferenceChange

    Consider that you have a generator at bus 102, named "generator-102-1" in your system called sys. The constructor to change is active power reference to 0.5 is:

    g = get_component(DynamicGenerator, sys, "generator-102-1")
    +crc = ControlReferenceChange(1.0, g, :P_ref, 0.5)

    Example 7: LoadChange

    Consider that you have a load at bus 103, named "load-103-1" in your system called sys. The constructor to change is active power reference to 0.8 per unit at $t = 1.0$ seconds is:

    l_device = get_component(ElectricLoad, sys, "load-103-1")
    +l_change = LoadChange(1.0, l_device, :P_ref, 0.8)

    Example 8: LoadTrip

    Consider that you have a load at bus 103, named "load-103-1" in your system called sys. The constructor to disconnect such load at $t = 1.0$ seconds is:

    l_device = get_component(ElectricLoad, sys, "load-103-1")
    +l_trip = LoadTrip(1.0, l_device)

    Example 9: SourceBusVoltageChange

    Consider that you have a voltage source at bus 101, named "source-101-1" in your system called sys. The constructor to change is voltage magnitude reference to 1.02 per unit at $t = 1.0$ seconds is:

    s_device = get_component(Source, sys, "source-101-1")
    +s_change = SourceBusVoltageChange(1.0, s_device, 1, 1.02)
    diff --git a/previews/PR360/power-simulations-dynamics.log b/previews/PR360/power-simulations-dynamics.log new file mode 100644 index 000000000..bd18d79c3 --- /dev/null +++ b/previews/PR360/power-simulations-dynamics.log @@ -0,0 +1,44 @@ +┌ Info: 2024-01-05T17:41:23.054 [5393:1]: The reference Bus has a Source connected to it. The frequency reference model will change to ConstantFrequency +└ @ PowerSimulationsDynamics /home/runner/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/frequency_reference.jl:70 +┌ Info: 2024-01-05T17:41:23.086 [5393:1]: Pre-Initializing Simulation States +└ @ PowerSimulationsDynamics /home/runner/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:265 +┌ Info: 2024-01-05T17:41:23.086 [5393:1]: Unit System changed to UnitSystem.SYSTEM_BASE = 0 +└ @ PowerSystems /home/runner/.julia/packages/PowerSystems/diJIg/src/base.jl:395 +┌ Info: 2024-01-05T17:41:24.920 [5393:1]: PowerFlow solve converged, the results have been stored in the system +└ @ PowerFlows /home/runner/.julia/packages/PowerFlows/8MBjq/src/nlsolve_ac_powerflow.jl:47 +┌ Info: 2024-01-05T17:41:24.920 [5393:1]: Unit System changed to UnitSystem.DEVICE_BASE = 1 +└ @ PowerSystems /home/runner/.julia/packages/PowerSystems/diJIg/src/base.jl:395 +┌ Info: 2024-01-05T17:41:37.941 [5393:1]: Residual from initial guess: max = 4.212807880321634e-11 at 4, total = 5.4841923110646186e-11 +└ @ PowerSimulationsDynamics /home/runner/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/nlsolve_wrapper.jl:101 +┌ Info: 2024-01-05T17:41:37.983 [5393:1]: Initialization non-linear solve succeeded with a tolerance of 1.0e-9 using solver trust_region. Saving solution. +└ @ PowerSimulationsDynamics /home/runner/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/nlsolve_wrapper.jl:68 +┌ Info: 2024-01-05T17:41:37.983 [5393:1]: Attaching Perturbations +└ @ PowerSimulationsDynamics /home/runner/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:296 +┌ Info: 2024-01-05T17:41:38.529 [5393:1]: Simulations status = BUILT +└ @ PowerSimulationsDynamics /home/runner/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:428 +┌ Info: 2024-01-05T17:41:38.529 [5393:1]: +│ ─────────────────────────────────────────────────────────────────────────────── +│ Time Allocations +│ ─────────────── ─────────────── +│ Total measured: 17.5s 810MiB +│ +│ Section ncalls time %tot alloc %tot +│ ─────────────────────────────────────────────────────────────────────────────── +│ Build Simulation 1 17.5s 100.0% 810MiB 100.0% +│ Build Simulation Inputs 1 2.06s 11.8% 127MiB 15.7% +│ Wrap Branches 1 12.0μs 0.0% 208B 0.0% +│ Wrap Dynamic Injectors 1 1.18s 6.8% 80.1MiB 9.9% +│ Calculate MM, DAE_vector, Tota... 1 78.9ms 0.5% 6.31MiB 0.8% +│ Wrap Static Injectors 1 64.7ms 0.4% 1.63MiB 0.2% +│ Pre-initialization 1 5.02s 28.7% 229MiB 28.3% +│ Power Flow solution 1 1.88s 10.7% 41.6MiB 5.1% +│ Initialize Static Injectors 1 2.26s 12.9% 27.5MiB 3.4% +│ Initialize Dynamic Injectors 1 886ms 5.1% 160MiB 19.8% +│ Calculate Jacobian 1 4.63s 26.5% 397MiB 49.0% +│ Make Model Function 1 6.55ms 0.0% 122KiB 0.0% +│ Initial Condition NLsolve refine... 1 5.24s 29.9% 29.7MiB 3.7% +│ Build Perturbations 1 236ms 1.3% 13.3MiB 1.6% +│ Make DiffEq Problem 1 304ms 1.7% 13.9MiB 1.7% +│ ─────────────────────────────────────────────────────────────────────────────── +│ +└ @ PowerSimulationsDynamics /home/runner/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:453 diff --git a/previews/PR360/quick_start_guide/index.html b/previews/PR360/quick_start_guide/index.html new file mode 100644 index 000000000..dcf3a06d2 --- /dev/null +++ b/previews/PR360/quick_start_guide/index.html @@ -0,0 +1,103 @@ + +Quick Start Guide · PowerSimulationsDynamics.jl

    Quick Start Guide

    The data for these tutorials is provided in PowerSystemCaseBuilder. If you want to build your own case, take a look at the tutorial Creating and Handling Data for Dynamic Simulations

    For more details about loading data and adding more dynamic components check the Creating a System with Dynamic devices section of the documentation in PowerSystems.jl.

    For a detailed tutorial about this case visit One Machine against Infinite Bus (OMIB) Simulation

    Loading data

    Data can be loaded from a pss/e raw file and a pss/e dyr file.

    julia> using PowerSystems
    julia> using PowerSimulationsDynamics
    julia> using PowerSystemCaseBuilder
    julia> using Sundials
    julia> using Plots
    julia> omib_sys = build_system(PSIDSystems, "OMIB System")┌ Info: Building new system OMIB System from raw data +└ sys_descriptor.raw_data = "" +┌ Warning: System is saved in the data format version 2.0.0 will be automatically upgraded to 3.0.0 upon saving +└ @ PowerSystems ~/.julia/packages/PowerSystems/diJIg/src/data_format_conversions.jl:82 +┌ Warning: struct ACBus does not exist in validation configuration file, validation skipped +└ @ InfrastructureSystems ~/.julia/packages/InfrastructureSystems/LWhzb/src/validation.jl:51 +┌ Warning: struct ACBus does not exist in validation configuration file, validation skipped +└ @ InfrastructureSystems ~/.julia/packages/InfrastructureSystems/LWhzb/src/validation.jl:51 +┌ Warning: struct DynamicGenerator does not exist in validation configuration file, validation skipped +└ @ InfrastructureSystems ~/.julia/packages/InfrastructureSystems/LWhzb/src/validation.jl:51 +┌ Warning: field prime_mover_type does not exist in ThermalStandard validation config +└ @ InfrastructureSystems ~/.julia/packages/InfrastructureSystems/LWhzb/src/validation.jl:65 +┌ Warning: struct DynamicGenerator does not exist in validation configuration file, validation skipped +└ @ InfrastructureSystems ~/.julia/packages/InfrastructureSystems/LWhzb/src/validation.jl:51 +┌ Warning: System is saved in the data format version 2.0.0 will be automatically upgraded to 3.0.0 upon saving +└ @ PowerSystems ~/.julia/packages/PowerSystems/diJIg/src/data_format_conversions.jl:110 +┌ Warning: There are no ElectricLoad Components in the System +└ @ PowerSystems ~/.julia/packages/PowerSystems/diJIg/src/utils/IO/system_checks.jl:59 +[ Info: Serialized System to /home/runner/.julia/packages/PowerSystemCaseBuilder/E76Gu/data/serialized_system/NoArgs/OMIB System.json +[ Info: Serialized System metadata to /home/runner/.julia/packages/PowerSystemCaseBuilder/E76Gu/data/serialized_system/NoArgs/OMIB System_metadata.json +System +┌───────────────────┬─────────────┐ +│ Property │ Value │ +├───────────────────┼─────────────┤ +│ Name │ │ +│ Description │ │ +│ System Units Base │ SYSTEM_BASE │ +│ Base Power │ 100.0 │ +│ Base Frequency │ 60.0 │ +│ Num Components │ 10 │ +└───────────────────┴─────────────┘ + +Static Components +┌─────────────────┬───────┬────────────────────────┬───────────────┐ +│ Type │ Count │ Has Static Time Series │ Has Forecasts │ +├─────────────────┼───────┼────────────────────────┼───────────────┤ +│ ACBus │ 2 │ false │ false │ +│ Arc │ 1 │ false │ false │ +│ Area │ 1 │ false │ false │ +│ Line │ 2 │ false │ false │ +│ LoadZone │ 1 │ false │ false │ +│ Source │ 1 │ false │ false │ +│ ThermalStandard │ 1 │ false │ false │ +└─────────────────┴───────┴────────────────────────┴───────────────┘ + +Dynamic Components +┌──────────────────┬───────┐ +│ Type │ Count │ +├──────────────────┼───────┤ +│ DynamicGenerator │ 1 │ +└──────────────────┴───────┘

    Define the Simulation

    julia> time_span = (0.0, 30.0)(0.0, 30.0)
    julia> perturbation_trip = BranchTrip(1.0, Line, "BUS 1-BUS 2-i_1")BranchTrip(1.0, Line, "BUS 1-BUS 2-i_1")
    julia> sim = Simulation!(ResidualModel, omib_sys, pwd(), time_span, perturbation_trip)[ Info: Unit System changed to UnitSystem.DEVICE_BASE = 1 +Simulation Summary +┌─────────────────────────┬────────────────┐ +│ Property │ Value │ +├─────────────────────────┼────────────────┤ +│ Status │ BUILT │ +│ Simulation Type │ Residual Model │ +│ Initialized? │ Yes │ +│ Multimachine system? │ No │ +│ Time Span │ (0.0, 30.0) │ +│ Number of States │ 6 │ +│ Number of Perturbations │ 1 │ +└─────────────────────────┴────────────────┘

    Explore initial conditions for the simulation

    julia> x0_init = read_initial_conditions(sim)Dict{String, Any} with 5 entries:
    +  "generator-102-1" => Dict(:ω=>1.0, :δ=>0.168525)
    +  "V_R"             => Dict(102=>1.03973, 101=>1.05)
    +  "Vm"              => Dict(102=>1.04, 101=>1.05)
    +  "θ"               => Dict(102=>0.0228958, 101=>0.0)
    +  "V_I"             => Dict(102=>0.0238095, 101=>0.0)
    julia> show_states_initial_value(sim)Voltage Variables
    +====================
    +BUS 1
    +====================
    +Vm 1.05
    +θ 0.0
    +====================
    +BUS 2
    +====================
    +Vm 1.04
    +θ 0.0229
    +====================
    +====================
    +Differential States
    +generator-102-1
    +====================
    +δ 0.1685
    +ω 1.0
    +====================

    Obtain small signal results for initial conditions

    Show eigenvalues for operating point

    julia>     small_sig = small_signal_analysis(sim)The system is small signal stable
    julia> summary_eigenvalues(small_sig)2×6 DataFrame + Row │ Most Associated Part. Factor Real Part Imag. Part Damping [%] Fr ⋯ + │ Any Any Any Any Any An ⋯ +─────┼────────────────────────────────────────────────────────────────────────── + 1 │ generator-102-1 δ 0.5 -0.158831 -13.2643 1.19735 2. ⋯ + 2 │ generator-102-1 δ 0.5 -0.158831 13.2643 1.19735 2. + 1 column omitted

    Execute the simulation

    julia>     execute!(sim, IDA(), dtmax = 0.02, saveat = 0.02, enable_progress_bar = false)SIMULATION_FINALIZED::BUILD_STATUS = 6

    Make a plot of the results

    julia> results = read_results(sim)Simulation Results Summary
    +┌────────────────────────────┬─────────────┐
    +│ Property                   │ Value       │
    +├────────────────────────────┼─────────────┤
    +│ System Base Power [MVA]    │ 100.0       │
    +│ System Base Frequency [Hz] │ 60.0        │
    +│ Time Span                  │ (0.0, 30.0) │
    +│ Total Time Steps           │ 1502        │
    +│ Number of States           │ 6           │
    +│ Total solve time           │ 3.708063182 │
    +└────────────────────────────┴─────────────┘
    julia> angle = get_state_series(results, ("generator-102-1", :δ));
    julia> plot(angle, xlabel = "time", ylabel = "rotor angle [rad]", label = "gen-102-1")Plot{Plots.GRBackend() n=1}

    plot

    If you miss PSS/e's plotting aesthetics and want something that resembles that, you can use UnicodePlots.

    julia> using UnicodePlots
    julia> unicodeplots()Plots.UnicodePlotsBackend()
    julia> plot(angle, xlabel = "time", ylabel = "rotor angle [rad]", label = "gen-102-1");

    plot

    diff --git a/previews/PR360/reference_frames/index.html b/previews/PR360/reference_frames/index.html new file mode 100644 index 000000000..2bbdcee2a --- /dev/null +++ b/previews/PR360/reference_frames/index.html @@ -0,0 +1,11 @@ + +Reference Frames · PowerSimulationsDynamics.jl

    Reference Frames

    Each dynamic device is defined in its own $dq$ synchronous reference frame (SRF). It is important to note that there are several conventions to do reference frame transformations.

    Synchronous Machines

    The grid is modeled in its own real-imaginary (RI) reference frame. With such, this follows the standard convention that for a voltage angle $\theta = 0$, there is no imaginary part and hence $v_h = v_r + j0$. Traditionally, the reference frame $dq$ with rotor angle $\delta$ for synchronous machines connected to a bus $v_h\angle \theta = v_r + jv_i$ follows the following convention for transformation of per-unit RMS phasors:

    \[\begin{align} +v_d + jv_q &= (v_r + jv_i) e^{-j(\delta- \pi/2)} \tag{1a} \\ +v_d &= v_h \sin(\delta - \theta) \tag{1b} \\ +v_q &= v_h \cos(\delta - \theta) \tag{1c} \\ +\left[ \begin{array}{c} v_d \\ v_q \end{array} \right] &= \left[ \begin{array}{cc} \sin(\delta) & -\cos(\delta) \\ \cos(\delta) & \sin(\delta) \end{array} \right] \left[ \begin{array}{c} v_r \\ v_i \end{array} \right] \tag{1d} +\end{align}\]

    Note that hence in a bus of $1.0\angle 0$, a rotor angle of $\delta = 0$ implies that $v_q = 1.0$ and $v_d = 0.0$. This transformation is the one that can be found in most books of Power Systems, such as Kundur, Sauer Pai and in Milano too, and is the convention used in the software to model dynamic models of synchronous machines in their own reference frame.

    Inverters

    The previously convention is not the standard one used for modeling inverters. Most of inverter and phase-lock loop (PLL) models follow the next convention:

    \[\begin{align} +v_d + jv_q &= (v_r + jv_i) e^{-j \delta} \tag{2a} \\ +v_d &= v_h \cos(\delta - \theta) \tag{2b} \\ +v_q &= -v_h \sin(\delta - \theta) \tag{2c} +\end{align}\]

    That, contrary to the previous case, when $\delta = \theta = 0$ implies that $v_d = 1.0$ and $v_q = 0.0$. This yields the typical PLL conditions that steer $v_q \to 0$ when $\delta$ locks in $\theta$, or when both SRF lock between each other.

    Transformation used

    Given the predominancy of both convention in current work, the software uses both conventions depending on the device modeled. For synchronous machines we used the standard convention (1a)-(1d), while for inverter models we use the predominant convention used nowadays in such models, i.e. (2a)-(2c).

    diff --git a/previews/PR360/search/index.html b/previews/PR360/search/index.html new file mode 100644 index 000000000..dbcbff834 --- /dev/null +++ b/previews/PR360/search/index.html @@ -0,0 +1,2 @@ + +Search · PowerSimulationsDynamics.jl diff --git a/previews/PR360/search_index.js b/previews/PR360/search_index.js new file mode 100644 index 000000000..3b437a618 --- /dev/null +++ b/previews/PR360/search_index.js @@ -0,0 +1,3 @@ +var documenterSearchIndex = {"docs": +[{"location":"execute/#Executing-a-Simulation","page":"Simulation Execution","title":"Executing a Simulation","text":"","category":"section"},{"location":"execute/","page":"Simulation Execution","title":"Simulation Execution","text":"After constructing the System data from PowerSystems.jl with its dynamic components, a Simulation structure must be constructed. Check the API for Simulation and Simulation! for its construction and available arguments.","category":"page"},{"location":"execute/","page":"Simulation Execution","title":"Simulation Execution","text":"Once a Simulation is constructed and properly initialized, the execute! command is used to run the Simulation. If no perturbation was included, then a steady state simulation will be run over the time span defined. See the API of execute! for more details.","category":"page"},{"location":"execute/#Solvers","page":"Simulation Execution","title":"Solvers","text":"","category":"section"},{"location":"execute/","page":"Simulation Execution","title":"Simulation Execution","text":"Solvers must be chosen accordingly depending on the type of model used in the Simulation. For example, a Residual model can be executed using Sundials IDA solver:","category":"page"},{"location":"execute/","page":"Simulation Execution","title":"Simulation Execution","text":"using Sundials\nsim = Simulation(\n ResidualModel,\n sys,\n pwd(),\n (0.0, 20.0),\n perturbation,\n)\nexecute!(sim, IDA())","category":"page"},{"location":"execute/","page":"Simulation Execution","title":"Simulation Execution","text":"Results can be explored using:","category":"page"},{"location":"execute/","page":"Simulation Execution","title":"Simulation Execution","text":"results = read_results(sim)","category":"page"},{"location":"execute/","page":"Simulation Execution","title":"Simulation Execution","text":"Similarly, a Mass Matrix model can be executed using Rodas4 solver.","category":"page"},{"location":"execute/","page":"Simulation Execution","title":"Simulation Execution","text":"using OrdinaryDiffEq\nsim2 = Simulation(\n MassMatrixModel,\n sys,\n pwd(),\n (0.0, 20.0),\n perturbation,\n)\nexecute!(sim2, Rodas4())","category":"page"},{"location":"execute/#Exploring-the-Solution","page":"Simulation Execution","title":"Exploring the Solution","text":"","category":"section"},{"location":"execute/","page":"Simulation Execution","title":"Simulation Execution","text":"Once a Simulation is executed and the results are stored via results = read_results(sim), the following functions can be used to explore the Simulation solution:","category":"page"},{"location":"execute/#Show-initial-conditions","page":"Simulation Execution","title":"Show initial conditions","text":"","category":"section"},{"location":"execute/","page":"Simulation Execution","title":"Simulation Execution","text":"The function show_states_initial_value(results) can be used to display the initial condition of the voltages and dynamic states of each dynamic component.","category":"page"},{"location":"execute/#Explore-bus-voltages","page":"Simulation Execution","title":"Explore bus voltages","text":"","category":"section"},{"location":"execute/","page":"Simulation Execution","title":"Simulation Execution","text":"The function get_voltage_magnitude_series(results, BusNumber) can be used to obtain the voltage magnitude time series of the specified bus. Similarly, get_voltage_angle_series(results, BusNumber) can be used to obtain the voltage angle time series of the specified bus.","category":"page"},{"location":"execute/#Explore-output-currents","page":"Simulation Execution","title":"Explore output currents","text":"","category":"section"},{"location":"execute/","page":"Simulation Execution","title":"Simulation Execution","text":"The functions get_real_current_series(results, \"DeviceName\") and get_imaginary_current_series(results, \"DeviceName\") can be used to obtain the output current time series of the specified device.","category":"page"},{"location":"execute/#Explore-output-power","page":"Simulation Execution","title":"Explore output power","text":"","category":"section"},{"location":"execute/","page":"Simulation Execution","title":"Simulation Execution","text":"The functions get_activepower_series(results, \"DeviceName\") and get_reactivepower_series(results, \"DeviceName\") can be used to obtain the output power time series of the specified device.","category":"page"},{"location":"execute/#Explore-dynamic-states","page":"Simulation Execution","title":"Explore dynamic states","text":"","category":"section"},{"location":"execute/","page":"Simulation Execution","title":"Simulation Execution","text":"The function get_state_series(results, (\"DeviceName\", :StateSymbol) can be used to obtain the specified state time series of the specified device.","category":"page"},{"location":"execute/#Explore-Reference-Setpoints","page":"Simulation Execution","title":"Explore Reference Setpoints","text":"","category":"section"},{"location":"execute/","page":"Simulation Execution","title":"Simulation Execution","text":"The function get_setpoints(sim) can be used to obtain the reference setpoints of each dynamic device. Note: If a setpoint was changed via a perturbation, this function will return the modified setpoint.","category":"page"},{"location":"execute/#Keyword-Arguments","page":"Simulation Execution","title":"Keyword Arguments","text":"","category":"section"},{"location":"execute/","page":"Simulation Execution","title":"Simulation Execution","text":"Any solver option available in DifferentialEquations.jl can be passed as keyword arguments in the execute! function. Please see the Common Solver Options in the DifferentialEquations.jl documentation for more details.","category":"page"},{"location":"execute/","page":"Simulation Execution","title":"Simulation Execution","text":"Most common solver options used are dtmax to control the maximum dt for adaptive timestepping. abstol and reltol are also commonly used to control the tolerance in the adaptive timestepping. saveat is also used to store the results at a specified time stamps. For example, the following code is valid to further specify your solver options:","category":"page"},{"location":"execute/","page":"Simulation Execution","title":"Simulation Execution","text":"execute!(sim, IDA(), dtmax = 0.01, abstol = 1e-9, reltol = 1e-6, saveat = 0.01)","category":"page"},{"location":"execute/","page":"Simulation Execution","title":"Simulation Execution","text":"In addition, the keyword argument enable_progress_bar = false can be used to disable the progress bar.","category":"page"},{"location":"component_models/inner_control/#Inner-Loop-Controls","page":"Inner Control","title":"Inner Loop Controls","text":"","category":"section"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"This component defines voltage and current controllers to generate the reference signal for the converter. Although in many controls the current and voltage control are separate blocks we propose a more general control approach that considers them as a joint control logic.","category":"page"},{"location":"component_models/inner_control/#Integrated-Virtual-Impedance,-Voltage-and-Current-Controller-[VoltageModeControl]","page":"Inner Control","title":"Integrated Virtual Impedance, Voltage and Current Controller [VoltageModeControl]","text":"","category":"section"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"The following model receives both the outer loop control frequency and reference voltage signal to generate the reference signal for the converters. The virtual impedance plays a similar role of the impedance of a synchronous generator. A PI voltage controller is used to generate the current signal that is used in the PI current controller to finally generate the voltage reference signal for the converters.","category":"page"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"beginalign*\n dotxi_d = v_dtextvi^textref - v_d tag1a \n dotxi_q = v_qtextvi^textref - v_q tag1b \n dotgamma_d = i_dtextcv^textref - i_dtextcv tag1c \n dotgamma_q = i_qtextcv^textref - i_qtextcv tag1d \n dotphi_d = omega_textad(v_d - phi_d) tag1e \n dotphi_q = omega_textad(v_q - phi_q) tag1f\nendalign*","category":"page"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"with","category":"page"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"beginalign\n v_dtextvi^textref = v_textolc^textref - r_v i_d + omega_textolc l_v i_q tag1g \n v_qtextvi^textref = - r_v i_q - omega_textolc l_v i_d tag1h \n i_dtextcv^textref = k_pvleft(v_dtextvi^textref - v_dright) + k_iv xi_d - c_f omega_textolc v_q + k_textffii_d tag1i \n i_qtextcv^textref = k_pvleft(v_qtextvi^textref - v_qright) + k_iv xi_q + c_f omega_textolc v_d + k_textffii_q tag1j \n v_d^textref-signal = k_pc left(i_dtextcv^textref - i_dtextcvright) + k_ic gamma_d - omega_textolc l_f i_qtextcv + k_textffvv_d - k_textad(v_d - phi_d) tag1k \n v_q^textref-signal = k_pc left(i_qtextcv^textref - i_qtextcvright) + k_ic gamma_q + omega_textolc l_f i_dtextcv + k_textffvv_q - k_textad(v_q - phi_q) tag1l\nendalign","category":"page"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"In here the transformation to the dq reference frame is using the outer-loop reference angle as:","category":"page"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"beginalign*\nv_d + jv_q = (v_r + jv_i)e^-jdeltatheta_olc \ni_d + ji_q = (i_r + ji_i)e^-jdeltatheta_olc\nendalign*","category":"page"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"that again v_r + jv_i could be in the capacitor or the last branch of the filter (i.e. the point of common coupling). For LCL filters it is considered in the capacitor. In the case of the converter, the transformation is directly","category":"page"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"beginalign*\ni_dtextcv + ji_qtextcv = (i_rtextcv + ji_itextcv)e^-jdeltatheta_olc\nendalign*","category":"page"},{"location":"component_models/inner_control/#Current-Mode-Controller-[CurrentModeControl]","page":"Inner Control","title":"Current Mode Controller [CurrentModeControl]","text":"","category":"section"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"The following model receives the current reference (in dq axis) from an outer loop controller that outputs current references such as the PI outer controller used for grid following inverters. A PI current controller is used to generate the voltage reference signal for the converters.","category":"page"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"beginalign*\n dotgamma_d = i_dtextcv^textref - i_dtextcv tag2a \n dotgamma_q = i_qtextcv^textref - i_qtextcv tag2b \nendalign*","category":"page"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"with","category":"page"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"beginalign\n v_d^textref-signal = k_pc left(i_dtextcv^textref - i_dtextcvright) + k_ic gamma_d - omega_textolc l_f i_qtextcv + k_textffvv_d tag2b \n v_q^textref-signal = k_pc left(i_qtextcv^textref - i_qtextcvright) + k_ic gamma_q + omega_textolc l_f i_dtextcv + k_textffvv_q tag2c\nendalign","category":"page"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"The transformation for the converter current is computed as:","category":"page"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"beginalign*\ni_dtextcv + ji_qtextcv = (i_rtextcv + ji_itextcv)e^-jtheta_olc\nendalign*","category":"page"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"In here theta_olc is the outer-loop angle. In the case of grid-following models, this angle is equal to the angle provided from the PLL.","category":"page"},{"location":"component_models/inner_control/#Generic-Renewable-Inner-Controller-Type-B-[RECurrentControlB]","page":"Inner Control","title":"Generic Renewable Inner Controller Type B [RECurrentControlB]","text":"","category":"section"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"This models the inner control part of the REECB model. The equations (without limiters) when Q_Flag = 1 are:","category":"page"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"beginalign\n T_rv dotV_texttflt = V_t - dotV_texttflt tag3a \n dotxi_icv = V_textocqcmd tag3b\nendalign","category":"page"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"on which V_textocqcmd comes from the Outer Controller and the output current commands I_textpcmd and I_textqcmd are computed as:","category":"page"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"beginalign\n I_textpcmd = I_textoc pcmd tag3c \n I_textqcmd = I_icv + I_textqinj tag3d \n I_icv = K_vp V_textocqcmd + K_vi xi_icv tag3e \n I_textqinj = K_qv (V_textref0 - V_texttflt) tag3f\nendalign","category":"page"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"The equations when Q_Flag = 0 are:","category":"page"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"beginalign\n T_rv dotV_texttflt = V_t - dotV_texttflt tag3g \n T_iq dotI_icv = I_textocqcmd - I_icv tag3h\nendalign","category":"page"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"on which I_textocqcmd comes from the Outer Controller and the output current commands I_textpcmd and I_textqcmd are computed as:","category":"page"},{"location":"component_models/inner_control/","page":"Inner Control","title":"Inner Control","text":"beginalign\n I_textpcmd = I_textoc pcmd tag3i \n I_textqcmd = I_icv + I_textqinj tag3j \n I_textqinj = K_qv (V_textref0 - V_texttflt) tag3k\nendalign","category":"page"},{"location":"quick_start_guide/#Quick-Start-Guide","page":"Quick Start Guide","title":"Quick Start Guide","text":"","category":"section"},{"location":"quick_start_guide/","page":"Quick Start Guide","title":"Quick Start Guide","text":"The data for these tutorials is provided in PowerSystemCaseBuilder. If you want to build your own case, take a look at the tutorial Creating and Handling Data for Dynamic Simulations","category":"page"},{"location":"quick_start_guide/","page":"Quick Start Guide","title":"Quick Start Guide","text":"For more details about loading data and adding more dynamic components check the Creating a System with Dynamic devices section of the documentation in PowerSystems.jl.","category":"page"},{"location":"quick_start_guide/","page":"Quick Start Guide","title":"Quick Start Guide","text":"For a detailed tutorial about this case visit One Machine against Infinite Bus (OMIB) Simulation","category":"page"},{"location":"quick_start_guide/#Loading-data","page":"Quick Start Guide","title":"Loading data","text":"","category":"section"},{"location":"quick_start_guide/","page":"Quick Start Guide","title":"Quick Start Guide","text":"Data can be loaded from a pss/e raw file and a pss/e dyr file.","category":"page"},{"location":"quick_start_guide/","page":"Quick Start Guide","title":"Quick Start Guide","text":"using PowerSystems\nusing PowerSimulationsDynamics\nusing PowerSystemCaseBuilder\nusing Sundials\nusing Plots\n\nomib_sys = build_system(PSIDSystems, \"OMIB System\")","category":"page"},{"location":"quick_start_guide/#Define-the-Simulation","page":"Quick Start Guide","title":"Define the Simulation","text":"","category":"section"},{"location":"quick_start_guide/","page":"Quick Start Guide","title":"Quick Start Guide","text":"time_span = (0.0, 30.0)\nperturbation_trip = BranchTrip(1.0, Line, \"BUS 1-BUS 2-i_1\")\nsim = Simulation!(ResidualModel, omib_sys, pwd(), time_span, perturbation_trip)","category":"page"},{"location":"quick_start_guide/#Explore-initial-conditions-for-the-simulation","page":"Quick Start Guide","title":"Explore initial conditions for the simulation","text":"","category":"section"},{"location":"quick_start_guide/","page":"Quick Start Guide","title":"Quick Start Guide","text":"x0_init = read_initial_conditions(sim)","category":"page"},{"location":"quick_start_guide/","page":"Quick Start Guide","title":"Quick Start Guide","text":"show_states_initial_value(sim)","category":"page"},{"location":"quick_start_guide/#Obtain-small-signal-results-for-initial-conditions","page":"Quick Start Guide","title":"Obtain small signal results for initial conditions","text":"","category":"section"},{"location":"quick_start_guide/","page":"Quick Start Guide","title":"Quick Start Guide","text":"Show eigenvalues for operating point","category":"page"},{"location":"quick_start_guide/","page":"Quick Start Guide","title":"Quick Start Guide","text":" small_sig = small_signal_analysis(sim)\n summary_eigenvalues(small_sig)","category":"page"},{"location":"quick_start_guide/#Execute-the-simulation","page":"Quick Start Guide","title":"Execute the simulation","text":"","category":"section"},{"location":"quick_start_guide/","page":"Quick Start Guide","title":"Quick Start Guide","text":" execute!(sim, IDA(), dtmax = 0.02, saveat = 0.02, enable_progress_bar = false)","category":"page"},{"location":"quick_start_guide/#Make-a-plot-of-the-results","page":"Quick Start Guide","title":"Make a plot of the results","text":"","category":"section"},{"location":"quick_start_guide/","page":"Quick Start Guide","title":"Quick Start Guide","text":"results = read_results(sim)\nangle = get_state_series(results, (\"generator-102-1\", :δ));\nplot(angle, xlabel = \"time\", ylabel = \"rotor angle [rad]\", label = \"gen-102-1\")","category":"page"},{"location":"quick_start_guide/","page":"Quick Start Guide","title":"Quick Start Guide","text":"(Image: plot)","category":"page"},{"location":"quick_start_guide/","page":"Quick Start Guide","title":"Quick Start Guide","text":"If you miss PSS/e's plotting aesthetics and want something that resembles that, you can use UnicodePlots.","category":"page"},{"location":"quick_start_guide/","page":"Quick Start Guide","title":"Quick Start Guide","text":"using UnicodePlots\nunicodeplots()\nplot(angle, xlabel = \"time\", ylabel = \"rotor angle [rad]\", label = \"gen-102-1\");","category":"page"},{"location":"quick_start_guide/","page":"Quick Start Guide","title":"Quick Start Guide","text":"(Image: plot)","category":"page"},{"location":"component_models/filters/#Filters","page":"Filter","title":"Filters","text":"","category":"section"},{"location":"component_models/filters/#LCL-Filter-[LCLFilter]","page":"Filter","title":"LCL Filter [LCLFilter]","text":"","category":"section"},{"location":"component_models/filters/","page":"Filter","title":"Filter","text":"A standard LCL filter is proposed to connect the output of the converter to the grid. In this case, v_r and v_i are voltages in the capacitor, while v_r^textgrid and v_i^textgrid represent the voltage at the bus. The L filter after the capacitor can also include a step-up transformer to increase the voltage, that is model as an extra impedance.","category":"page"},{"location":"component_models/filters/","page":"Filter","title":"Filter","text":"beginalign\n doti_rtextcv = fracOmega_bl_fleft( v_r^textcv - v_r - r_f i_rtextcv + omega_textgrid l_f i_itextcv right) tag1a \n doti_itextcv = fracOmega_bl_fleft( v_i^textcv - v_i - r_f i_itextcv - omega_textgrid l_f i_rtextcv right) tag1b \n dotv_r = fracOmega_bc_fleft( i_r^textcv - i_r + omega_textgrid c_f v_i right) tag1c \n dotv_i = fracOmega_bc_fleft( i_i^textcv - i_i - omega_textgrid c_f v_r right) tag1d \n doti_r = fracOmega_bl_gleft( v_r - v_r^textgrid - r_g i_r + omega_textgrid l_g i_itextcv right) tag1e \n doti_i = fracOmega_bl_gleft( v_i - v_i^textgrid - r_g i_i - omega_textgrid l_g i_rtextcv right) tag1f\nendalign","category":"page"},{"location":"component_models/filters/","page":"Filter","title":"Filter","text":"on which","category":"page"},{"location":"component_models/filters/","page":"Filter","title":"Filter","text":"beginalign*\nv_r^textcv + jv_i^textcv = (v_d^textcv + jv_q^textcv)e^jdeltatheta_olc\nendalign*","category":"page"},{"location":"component_models/filters/","page":"Filter","title":"Filter","text":"that comes from the converter model.","category":"page"},{"location":"component_models/filters/#RL-Filter-[RLFilter]","page":"Filter","title":"RL Filter [RLFilter]","text":"","category":"section"},{"location":"component_models/filters/","page":"Filter","title":"Filter","text":"The algebraic RL filter is used to connect the output of the converter through a RL series filter using algebraic phasor equations. The equations for the output current are:","category":"page"},{"location":"component_models/filters/","page":"Filter","title":"Filter","text":"beginalign\n i_r + ji_i = frac(v_r^textcv + j v_i^textcv) - (v_r^textgrid + jv_i^textgrid)r_f + jl_f tag2a\nendalign","category":"page"},{"location":"component_models/filters/","page":"Filter","title":"Filter","text":"on which v_r^textcv + jv_i^textcv comes from the converter model.","category":"page"},{"location":"tutorials/tutorial_activeload/#Tutorial-Active-Constant-Power-Load-model","page":"Active Load Model","title":"Tutorial Active Constant Power Load model","text":"","category":"section"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"Originally Contributed by: Rodrigo Henriquez-Auba","category":"page"},{"location":"tutorials/tutorial_activeload/#Introduction","page":"Active Load Model","title":"Introduction","text":"","category":"section"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"This tutorial will introduce you to the functionality of PowerSimulationsDynamics and PowerSystems to explore active load components and a small-signal analysis.","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"This tutorial presents a simulation of a two-bus system with a GFM inverter at bus 1, and a load on bus 2. We will change the model from a constant power load model, to a constant impedance model and then to a 12-state active constant power load model.","category":"page"},{"location":"tutorials/tutorial_activeload/#Dependencies","page":"Active Load Model","title":"Dependencies","text":"","category":"section"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"using PowerSimulationsDynamics;\nPSID = PowerSimulationsDynamics\nusing PowerSystemCaseBuilder\nusing PowerSystems\nconst PSY = PowerSystems;","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"note: Note\nPowerSystemCaseBuilder.jl is a helper library that makes it easier to reproduce examples in the documentation and tutorials. Normally you would pass your local files to create the system data instead of calling the function build_system. For more details visit PowerSystemCaseBuilder Documentation","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"PowerSystems (abbreviated with PSY) is used to properly define the data structure and establish an equilibrium point initial condition with a power flow routine using PowerFlows.","category":"page"},{"location":"tutorials/tutorial_activeload/#Load-the-system","page":"Active Load Model","title":"Load the system","text":"","category":"section"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"We load the system using PowerSystemCaseBuilder.jl. This system has an inverter located at bus 1.","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"sys = build_system(PSIDSystems, \"2 Bus Load Tutorial Droop\")","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"first(get_components(DynamicInverter, sys))","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"The load is an exponential load modeled as a constant power load since the coefficients are set to zero.","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"first(get_components(PSY.ExponentialLoad, sys))","category":"page"},{"location":"tutorials/tutorial_activeload/#Run-a-small-signal-analysis","page":"Active Load Model","title":"Run a small-signal analysis","text":"","category":"section"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"We set up the Simulation. Since the droop model does not have a frequency state, we use a constant frequency reference frame for the network.","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"sim = Simulation(ResidualModel,\n sys,\n mktempdir(),\n (0.0, 1.0),\n frequency_reference = ConstantFrequency())","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"The following provides a summary of eigenvalues for this droop system with a constant power load:","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"sm = small_signal_analysis(sim);\ndf = summary_eigenvalues(sm);\nshow(df, allrows = true, allcols = true)","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"In this inverter model, the filter is modeled using differential equations, and as described in the literature, interfacing a RL filter against an algebraic constant power load usually results in unstable behavior as observed with the positive real part eigenvalue.","category":"page"},{"location":"tutorials/tutorial_activeload/#Change-to-a-constant-impedance-load-model","page":"Active Load Model","title":"Change to a constant impedance load model","text":"","category":"section"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"Since the load is an exponential load model we can change the exponent coefficients to 2.0 to behave as a constant impedance model:","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"# Update load coefficients to 2.0\nload = first(get_components(PSY.ExponentialLoad, sys));\nPSY.set_active_power_coefficient!(load, 2.0);\nPSY.set_reactive_power_coefficient!(load, 2.0);","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"We then re-run the small-signal analysis:","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"sim = Simulation(ResidualModel,\n sys,\n mktempdir(),\n (0.0, 1.0),\n frequency_reference = ConstantFrequency())","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"sm = small_signal_analysis(sim);\ndf = summary_eigenvalues(sm);\nshow(df, allrows = true, allcols = true)","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"Observe that now the system is small-signal stable (since there is only one device the angle of the inverter is used as a reference, and hence is zero).","category":"page"},{"location":"tutorials/tutorial_activeload/#Adding-a-dynamic-active-load-model","page":"Active Load Model","title":"Adding a dynamic active load model","text":"","category":"section"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"To consider a dynamic model in the load it is only required to attach a dynamic component to the static load model. When a dynamic load model is attached, the active and reactive power of the static model are used to define reference parameters to ensure that the dynamic load model matches the static load output power.","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"Note that when a dynamic model is attached to a static model, the static model does not participate in the dynamic system equations, i.e. the only model interfacing to the network equations is the dynamic model and not the static model (the exponential load).","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"We define a function to create a active load model with the specific parameters:","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"# Parameters taken from active load model from N. Bottrell Masters\n# Thesis \"Small-Signal Analysis of Active Loads and Large-signal Analysis\n# of Faults in Inverter Interfaced Microgrid Applications\", 2014.\n\n# The parameters are then per-unitized to be scalable to represent an aggregation\n# of multiple active loads\n\n# Base AC Voltage: Vb = 380 V\n# Base Power (AC and DC): Pb = 10000 VA\n# Base AC Current: Ib = 10000 / 380 = 26.32 A\n# Base AC Impedance: Zb = 380 / 26.32 = 14.44 Ω\n# Base AC Inductance: Lb = Zb / Ωb = 14.44 / 377 = 0.3831 H\n# Base AC Capacitance: Cb = 1 / (Zb * Ωb) = 0.000183697 F\n# Base DC Voltage: Vb_dc = (√8/√3) Vb = 620.54 V\n# Base DC Current: Ib_dc = Pb / V_dc = 10000/620.54 = 16.12 A\n# Base DC Impedance: Zb_dc = Vb_dc / Ib_dc = 38.50 Ω\n# Base DC Capacitance: Cb_dc = 1 / (Zb_dc * Ωb) = 6.8886315e-5 F\n\nΩb = 2*pi*60;\nVb = 380;\nPb = 10000;\nIb = Pb / Vb;\nZb = Vb / Ib;\nLb = Zb / Ωb;\nCb = 1 / (Zb * Ωb);\nVb_dc = sqrt(8)/sqrt(3) * Vb;\nIb_dc = Pb / Vb_dc;\nZb_dc = Vb_dc / Ib_dc;\nCb_dc = 1/(Zb_dc * Ωb);\n\nfunction active_cpl(load)\n return PSY.ActiveConstantPowerLoad(\n name = get_name(load),\n r_load = 70.0 / Zb_dc,\n c_dc = 2040e-6 / Cb_dc,\n rf = 0.1 / Zb,\n lf = 2.3e-3 / Lb,\n cf = 8.8e-6 / Cb,\n rg = 0.03 / Zb,\n lg = 0.93e-3 / Lb,\n kp_pll = 0.4,\n ki_pll = 4.69,\n kpv = 0.5 * (Vb_dc / Ib_dc),\n kiv = 150.0 * (Vb_dc / Ib_dc),\n kpc = 15.0 * (Ib / Vb),\n kic = 30000.0 * (Ib / Vb),\n base_power = 100.0,\n )\nend","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"We then attach the model to the system:","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"load = first(get_components(PSY.ExponentialLoad, sys));\ndyn_load = active_cpl(load)\nadd_component!(sys, dyn_load, load)","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"Finally, we set up the simulation:","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"sim = Simulation(ResidualModel,\n sys,\n mktempdir(),\n (0.0, 1.0),\n frequency_reference = ConstantFrequency())","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"sm = small_signal_analysis(sim);\ndf = summary_eigenvalues(sm);\nshow(df, allrows = true, allcols = true)","category":"page"},{"location":"tutorials/tutorial_activeload/","page":"Active Load Model","title":"Active Load Model","text":"Observe the new states of the active load model and that the system is small-signal stable.","category":"page"},{"location":"component_models/turbine_gov/#Prime-Movers-and-Turbine-Governors-(TG)","page":"Turbine and Governor","title":"Prime Movers and Turbine Governors (TG)","text":"","category":"section"},{"location":"component_models/turbine_gov/","page":"Turbine and Governor","title":"Turbine and Governor","text":"This section describes how mechanical power is modified to provide primary frequency control with synchronous generators. It is assumed that tau_textref = P_textref since they are decided at nominal frequency omega = 1.","category":"page"},{"location":"component_models/turbine_gov/#Fixed-TG-[TGFixed]","page":"Turbine and Governor","title":"Fixed TG [TGFixed]","text":"","category":"section"},{"location":"component_models/turbine_gov/","page":"Turbine and Governor","title":"Turbine and Governor","text":"This a simple model that set the mechanical torque to be equal to a proportion of the desired reference tau_m = eta P_textref. To set the mechanical torque to be equal to the desired power, the value of eta is set to 1.","category":"page"},{"location":"component_models/turbine_gov/#TG-Type-I-[TGTypeI]","page":"Turbine and Governor","title":"TG Type I [TGTypeI]","text":"","category":"section"},{"location":"component_models/turbine_gov/","page":"Turbine and Governor","title":"Turbine and Governor","text":"This turbine governor is described by a droop controller and a low-pass filter to model the governor and two lead-lag blocks to model the servo and reheat of the turbine governor.","category":"page"},{"location":"component_models/turbine_gov/","page":"Turbine and Governor","title":"Turbine and Governor","text":"beginalign\ndotx_g1 = frac1T_s(p_textin - x_g1) tag1a \ndotx_g2 = frac1T_c left left(1- fract_3T_cright)x_g1 - x_g2 right tag1b \ndotx_g3 = frac1T_5 leftleft(1 - fracT_4T_5right)left(x_g2 + fracT_3T_cx_g1right) - x_g3 right tag1c \ntau_m = x_g3 + fracT_4T_5left(x_g2 + fracT_3T_cx_g1right) tag1d\nendalign","category":"page"},{"location":"component_models/turbine_gov/","page":"Turbine and Governor","title":"Turbine and Governor","text":"with","category":"page"},{"location":"component_models/turbine_gov/","page":"Turbine and Governor","title":"Turbine and Governor","text":"beginalign*\np_textin = P_textref + frac1R(omega_s - 10)\nendalign*","category":"page"},{"location":"component_models/turbine_gov/#TG-Type-II-[TGTypeII]","page":"Turbine and Governor","title":"TG Type II [TGTypeII]","text":"","category":"section"},{"location":"component_models/turbine_gov/","page":"Turbine and Governor","title":"Turbine and Governor","text":"This turbine governor is a simplified model of the Type I.","category":"page"},{"location":"component_models/turbine_gov/","page":"Turbine and Governor","title":"Turbine and Governor","text":"beginalign\ndotx_g = frac1T_2leftfrac1Rleft(1 - fracT_1T_2right) (omega_s - omega) - x_gright tag2a \ntau_m = P_textref + frac1RfracT_1T_2(omega_s - omega) tag2b\nendalign","category":"page"},{"location":"component_models/turbine_gov/#TGOV1-[SteamTurbineGov1]","page":"Turbine and Governor","title":"TGOV1 [SteamTurbineGov1]","text":"","category":"section"},{"location":"component_models/turbine_gov/","page":"Turbine and Governor","title":"Turbine and Governor","text":"This represents a classical Steam-Turbine Governor, known as TGOV1.","category":"page"},{"location":"component_models/turbine_gov/","page":"Turbine and Governor","title":"Turbine and Governor","text":"beginalign\ndotx_g1 = frac1T_1 (textref_in - x_g1) tag3a \ndotx_g2 = frac1T_3 left(x_g1^textsat left(1 - fracT_2T_3right) - x_g2right) tag3b\nendalign","category":"page"},{"location":"component_models/turbine_gov/","page":"Turbine and Governor","title":"Turbine and Governor","text":"with","category":"page"},{"location":"component_models/turbine_gov/","page":"Turbine and Governor","title":"Turbine and Governor","text":"beginalign\ntextref_in = frac1R (P_ref - (omega - 10)) tag3c \nx_g1^textsat = left beginarraycl\n x_g1 text if V_min le x_g1 le V_max\n V_max text if x_g1 V_max \n V_min text if x_g1 V_min\n endarray right tag3d \ntau_m = x_g2 + fracT_2T_3 x_g1 - D_T(omega - 10) tag3e\nendalign","category":"page"},{"location":"component_models/turbine_gov/#GAST-[GasTG]","page":"Turbine and Governor","title":"GAST [GasTG]","text":"","category":"section"},{"location":"component_models/turbine_gov/","page":"Turbine and Governor","title":"Turbine and Governor","text":"This turbine governor represents the Gas Turbine representation, known as GAST.","category":"page"},{"location":"component_models/turbine_gov/","page":"Turbine and Governor","title":"Turbine and Governor","text":"beginalign\ndotx_g1 = frac1T_1 (x_in - x_g1) tag4a \ndotx_g2 = frac1T_2 left(x_g1^textsat - x_g2right) tag4b \ndotx_g3 = frac1T_3 (x_g2 - x_g3) tag4c\nendalign","category":"page"},{"location":"component_models/turbine_gov/","page":"Turbine and Governor","title":"Turbine and Governor","text":"with","category":"page"},{"location":"component_models/turbine_gov/","page":"Turbine and Governor","title":"Turbine and Governor","text":"beginalign\nx_in = minleftP_ref - frac1R(omega - 10) A_T + K_T (A_T - x_g3) right tag4d \nx_g1^textsat = left beginarraycl\n x_g1 text if V_min le x_g1 le V_max\n V_max text if x_g1 V_max \n V_min text if x_g1 V_min\n endarray right tag4e \ntau_m = x_g2 - D_T(omega - 10) tag4f\nendalign","category":"page"},{"location":"component_models/turbine_gov/#HYGOV-[HydroTurbineGov]","page":"Turbine and Governor","title":"HYGOV [HydroTurbineGov]","text":"","category":"section"},{"location":"component_models/turbine_gov/","page":"Turbine and Governor","title":"Turbine and Governor","text":"This represents a classical hydro governor, known as HYGOV.","category":"page"},{"location":"component_models/turbine_gov/","page":"Turbine and Governor","title":"Turbine and Governor","text":"beginalign\nT_fdotx_g1 = P_in - x_g1 tag5a \ndotx_g2 = x_g1 tag5b\nT_g dotx_g3 = c - x_g3 tag5c\ndotx_g4 = frac1 - hT_w tag5d\nendalign","category":"page"},{"location":"component_models/turbine_gov/","page":"Turbine and Governor","title":"Turbine and Governor","text":"with","category":"page"},{"location":"component_models/turbine_gov/","page":"Turbine and Governor","title":"Turbine and Governor","text":"beginalign\nP_in = P_ref - Delta omega - R x_g2 tag5e \nc = fracx_g1r + fracx_g2rT_r tag5f \nh = left(fracx_g4x_g3right)^2 tag5g\ntau_m = hcdot A_t(x_g4 - q_NL) - D_turb Deltaomega cdot x_g3 tag5h\nendalign","category":"page"},{"location":"small/#Small-Signal-Analysis","page":"Small Signal","title":"Small Signal Analysis","text":"","category":"section"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"Here we discuss the method used to do a small signal analysis on the DAE system defined in PowerSimulationsDynamics.jl. The package defines algebraic variables for both real and imaginary voltages on all buses (except if they have a dynamic line connected, on which the voltage of those buses are treated as differential variables). In addition, each dynamic device can add differential variables (or states) that are concatenated to construct the system of differential algebraic equations.","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"Note: The validation of small signal results is still work in progress due to the differences in the way that different software packages perform the calculations.","category":"page"},{"location":"small/#Automatic-Differentiation","page":"Small Signal","title":"Automatic Differentiation","text":"","category":"section"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"Once an equilibrium point is found, the complete jacobian of the non-linear system can be obtained using automatic differentiation in Julia. In particular, the package ForwardDiff.jl is used to obtain the jacobian of the non-linear algebraic system of equations. PowerSimulationsDynamics.jl handles the resulting jacobian and reports the reduced jacobian and the corresponding eigenvalues and eigenvectors.","category":"page"},{"location":"small/#Jacobian-Reduction","page":"Small Signal","title":"Jacobian Reduction","text":"","category":"section"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"We define y as the vector of algebraic variables, x as the vector of differential variables (states) and p the parameters of the system, we can define g(yxp) as the vector of algebraic equations and f(yxp) as the vector of differential equations. With that, the non-linear differential algebraic system of equations can be written as:","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"beginalign\nleftbeginarrayc\n 0 \n dotx\n endarrayright = leftbeginarrayc\n g(yxp) \n f(yxp) endarrayright\nendalign","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"For small signal analysis, we are interested in the stability around an equilbrium point y_eqx_eq that satisfies dotx = 0 or equivalently f(y_eqx_eqp) = 0, while obviously satisfying g(y_eq x_eq p) = 0. To do that we use a first order approximation:","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"beginalign\nleftbeginarrayc\n 0 \n Deltadotx\n endarrayright = underbraceleftbeginarray\n g(y_eqx_eqp) \n f(y_eqx_eqp) endarrayright_ = 0\n + Jy_eq x_eq p leftbeginarrayc\n Delta y \n Delta x\n endarrayright\n endalign","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"The first to note is that the jacobian matrix can be splitted in 4 blocks depending on the specific variables we are taking the partial derivatives:","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"beginalign\nJy_eq x_eq p =\nleftbeginarraycc\n g_y g_x \n f_y f_x \n endarrayright\nendalign","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"For small signal analyses, we are interested in the stability of the differential states, while still considering that those need to evolve in the manifold defined by the linearized algebraic equations. Assuming that g_y is not singular (see chapter 7 of Federico Milano's book: Power System Modelling and Scripting or the following paper) we can eliminate the algebraic variables to obtain the reduced jacobian:","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"beginalign\nJ_textred = f_x - f_y g_y^-1 g_x\nendalign","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"that defines our reduced system for the differential variables","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"beginalign\nDelta dotx = J_textred Delta x\nendalign","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"on which we can compute its eigenvalues to analyze local stability.","category":"page"},{"location":"small/#Accessing-the-Jacobian-function","page":"Small Signal","title":"Accessing the Jacobian function","text":"","category":"section"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"You can retrieve the Jacobian function for a simulation using the get_jacobian function as follows:","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"jacobian = function get_jacobian(ResidualModel, system)","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"optionally you can pass the number of iterations to check for sparsity as follows:","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"jacobian = function get_jacobian(ResidualModel, system, 0)","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"if you specify 0, the jacobian function will use a full matrix.","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"The return of get_jacobian is known as a functor in Julia and can be used to make evaluations. Currently, any function can be evaluated with the following inputs:","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"jacobian(x)","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"This version of the function is type unstable should only be used for non-critial ops. It works to get the eigenvalues given an operating point x","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"jacobian(JM, x)","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"This version evaluates in place the value of the jacobian for an operating point x and writes to the matrix JM","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"jacobian(JM, x, p, t)","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"This version complied with the requirements to be used in DiffEq for ODE solvers. p and t aren't used they just mean to match the interfaces. See DiffEqDocs","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"jacobian(JM, dx, x, p, gamma, t)","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"This version complied with the requirements to be used in DiffEq for DAE solvers. p and t aren't used they just mean to match the interfaces. It assumes that the jacobian has the form:","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"beginalign\n JM = gamma * I + J(x)\nendalign","category":"page"},{"location":"small/","page":"Small Signal","title":"Small Signal","text":"See DiffEqDocs for additional details.","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"Here we discuss the models used to describe load modeling in PowerSimulationsDynamics.jl. In a similar fashion of other devices, loads will withdraw power (i.e. current) from the current-injection balances at the nodal level. Based on the specified parameters and model chosen, the equations for computing such withdrawal will change.","category":"page"},{"location":"component_models/loads/#Static-Loads-(or-Algebraic-Loads)","page":"Load Models","title":"Static Loads (or Algebraic Loads)","text":"","category":"section"},{"location":"component_models/loads/#ZIP-Exponential-Load-Model","page":"Load Models","title":"ZIP + Exponential Load Model","text":"","category":"section"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"PowerSimulationsDynamics.jl uses all the static ZIP and exponential loads at each bus to obtain a single structure that creates an aggregate ZIP load model and a collection of all exponential loads.","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"The ZIP load model given by:","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"beginalign\nP_textzip = P_textpower + P_textcurrent cdot fracVV_0 + P_textimpedance cdot left(fracVV_0right)^2 tag1a\nQ_textzip = Q_textpower + Q_textcurrent cdot fracVV_0 + Q_textimpedance cdot left(fracVV_0right)^2tag1b\nendalign","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"with V = sqrtV_r^2 + V_i^2 and V_0 the voltage magnitude from the power flow solution.","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"The current taken for the load is computed as:","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"beginalign\nI_textzip = frac(P_textzip + j Q_textzip)^*(V_r + j V_i)^*tag1c \nI_textzip = fracP_textzip - j Q_textzipV_r - j V_itag1d\nendalign","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"For constant impedance load, the current obtained is:","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"beginalign\nI_textre^z = frac1V_0^2 cdot (V_r cdot P_textimpedance + V_i cdot Q_textimpedance)tag1e \nI_textim^z = frac1V_0^2 cdot (V_i cdot P_textimpedance - V_r cdot Q_textimpedance)tag1f\nendalign","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"For constant current load, the current obtained is:","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"beginalign\nI_textre^i = frac1V_0 cdot fracV_r * P_textcurrent + V_i * Q_textcurrentV tag1g\nI_textim^i = frac1V_0 cdot fracV_i * P_textcurrent - V_r * Q_textcurrentV tag1h\nendalign","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"For constant power load, the current obtained is:","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"beginalign\nI_textre^p = fracV_r cdot P_textpower + V_i cdot Q_textpowerV^2 tag1i \nI_textim^p = fracV_i cdot P_textpower - V_r cdot Q_textpowerV^2 tag1j\nendalign","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"Then the total current withdrawed from the ZIP load model is simply","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"beginalign\nI_textzip^textre = I_textre^z + I_textre^i + I_textre^p tag1k \nI_textzip^textim = I_textim^z + I_textim^i + I_textim^p tag1l\nendalign","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"On the case of Exponential Loads, the model is given by:","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"beginalign\nP_textexp = P_0 cdot left(fracVV_0right)^alpha tag1m\nQ_textexp = Q_0 cdot left(fracVV_0right)^beta tag1n\nendalign","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"The current taken for the load is computed as:","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"beginalign\nI_textexp = frac(P_textexp + j Q_textexp)^*(V_r + j V_i)^* tag1o \nI_textexp = fracP_textexp - j Q_textexpV_r - j V_i tag1p\nendalign","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"that results:","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"beginalign\nI_textexp^textre = V_r cdot P_0 cdot fracV^alpha - 2V_0^alpha + V_i cdot Q_0 cdot fracV^beta - 2V_0^beta tag1q\nI_textexp^textim = V_i cdot P_0 cdot fracV^alpha - 2V_0^alpha - V_r cdot Q_0 cdot fracV^beta - 2V_0^beta tag1r\nendalign","category":"page"},{"location":"component_models/loads/#Dynamic-loads","page":"Load Models","title":"Dynamic loads","text":"","category":"section"},{"location":"component_models/loads/#th-order-Single-Cage-Induction-Machine-[SingleCageInductionMachine]","page":"Load Models","title":"5th-order Single Cage Induction Machine [SingleCageInductionMachine]","text":"","category":"section"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"The following model is used to model a 5th-order induction machine with a quadratic relationship speed-torque. Refer to \"Analysis of Electric Machinery and Drive Systems\" by Paul Krause, Oleg Wasynczuk and Scott Sudhoff for the equations derivation","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"beginalign\ndotpsi_qs = Omega_b (v_qs - omega_textsys psi_ds - R_s i_qs) tag2a\ndotpsi_ds = Omega_b (v_ds + omega_textsys psi_qs - R_s i_ds) tag2b \ndotpsi_qr = Omega_b left(v_qr - (omega_textsys - omega_r) psi_dr + fracR_rX_lr (psi_mq - psi_qr)right) tag2c\ndotpsi_dr = Omega_b left(v_dr + (omega_textsys - omega_r) psi_qr + fracR_rX_lr (psi_md - psi_dr)right) tag2d\ndotomega_r = frac12H (tau_e - tau_m0(A omega_r^2 + B omega_r + C)) tag2e\nendalign","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"where:","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"beginalign*\nX_ad = X_aq = left(frac1X_m + frac1X_ls + frac1X_lrright)^-1 \nv_qs = V_i^textbus \nv_ds = V_r^textbus \nv_qr = v_dr = 0 \npsi_mq = X_aq left(fracpsi_qsX_ls+ fracpsi_qrX_lrright) \npsi_md = X_ad left(fracpsi_dsX_ls+ fracpsi_drX_lrright) \ni_qs = frac1X_ls (psi_qs - psi_mq) \ni_ds = frac1X_ls (psi_ds - psi_md) \ntau_e = psi_ds i_qs - psi_qs i_ds \nendalign*","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"Finally, the withdrawed current from the bus is:","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"beginalign*\nI_r = left(fracS_textmotorS_textbaseright) (i_ds - v_qs B_sh) \nI_i = left(fracS_textmotorS_textbaseright) (i_qs + v_ds B_sh) \nendalign*","category":"page"},{"location":"component_models/loads/#rd-order-Single-Cage-Induction-Machine-[SimplifiedSingleCageInductionMachine]","page":"Load Models","title":"3rd-order Single Cage Induction Machine [SimplifiedSingleCageInductionMachine]","text":"","category":"section"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"The following models approximates the stator fluxes dynamics of the 5th-order model by using algebraic equations.","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"beginalign\ndotpsi_qr = Omega_b left(v_qr - (omega_textsys - omega_r) psi_dr - R_r i_qr right) tag3a \ndotpsi_dr = Omega_b left(v_dr + (omega_textsys - omega_r) psi_qr - R_r i_drright) tag3b \ndotomega_r = frac12H (tau_e - tau_m0(A omega_r^2 + B omega_r + C)) tag3c\nendalign","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"where","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"beginalign*\nv_qs = V_i^textbus \nv_ds = V_r^textbus \nv_qr = v_dr = 0 \ni_qs = frac1R_s^2 + omega_textsys^2 X_p^2 left( (R_s v_qs - omega_textsys X_p v_ds) - left(R_s omega_textsys fracX_mX_rr psi_dr + omega_textsys^2 X_p fracX_mX_rr psi_qr right) right) \ni_ds = frac1R_s^2 + omega_textsys^2 X_p^2 left( (R_s v_ds + omega_textsys X_p v_qs) - left(-R_s omega_textsys fracX_mX_rr psi_qr + omega_textsys^2 X_p fracX_mX_rr psi_dr right) right) \ni_qr = frac1X_rr (psi_qr - X_m i_qs) \ni_dr = frac1X_rr (psi_dr - X_m i_ds) \ntau_e = psi_qr i_dr - psi_dr i_qr \nendalign*","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"Finally, the withdrawed current from the bus is:","category":"page"},{"location":"component_models/loads/","page":"Load Models","title":"Load Models","text":"beginalign*\nI_r = left(fracS_textmotorS_textbaseright) (i_ds - v_qs B_sh) \nI_i = left(fracS_textmotorS_textbaseright) (i_qs + v_ds B_sh) \nendalign*","category":"page"},{"location":"tutorials/tutorial_240bus/#[PSSE-240-Bus-Case-system-with-Renewables](https://www.nrel.gov/grid/test-case-repository.html)","page":"240 WECC solver comparison","title":"PSSE 240 Bus Case system with Renewables","text":"","category":"section"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"Originally Contributed by: José Daniel Lara","category":"page"},{"location":"tutorials/tutorial_240bus/#Introduction","page":"240 WECC solver comparison","title":"Introduction","text":"","category":"section"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"This tutorial will introduce the industry models of Renewable Energy the comparisons between DiffEq Integration techniques for comparison. We show the uses of Sundials and OrdinaryDiffEq to obtain the transient response of a system to a perturbation.","category":"page"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"using PowerSimulationsDynamics\nusing PowerSystemCaseBuilder\nusing PowerSystems\nconst PSY = PowerSystems\nusing Sundials\nusing Plots\nusing OrdinaryDiffEq","category":"page"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"note: Note\nPowerSystemCaseBuilder.jl is a helper library that makes it easier to reproduce examples in the documentation and tutorials. Normally you would pass your local files to create the system data instead of calling the function build_system. For more details visit PowerSystemCaseBuilder Documentation","category":"page"},{"location":"tutorials/tutorial_240bus/#Load-the-system-and-transform-load-data","page":"240 WECC solver comparison","title":"Load the system and transform load data","text":"","category":"section"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"To load the system we use PowerSystemCaseBuilder.jl:","category":"page"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"# We remove the checks in this example to avoid large prints\nsys = build_system(PSIDSystems, \"WECC 240 Bus\"; runchecks = false)\n\n# Transform the system's load\nfor l in get_components(PSY.StandardLoad, sys)\n transform_load_to_constant_impedance(l)\nend","category":"page"},{"location":"tutorials/tutorial_240bus/#Build-the-simulation-and-initialize-the-problem","page":"240 WECC solver comparison","title":"Build the simulation and initialize the problem","text":"","category":"section"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"The next step is to create the simulation structure. This will create the indexing of our system that will be used to formulate the differential-algebraic system of equations. To do so, it is required to specify the perturbation that will occur in the system. In this case, we will use a ResidualModel formulation, for more details about the formulation checkout the Models Section in PowerSimulationsDynamics.jl documentation.","category":"page"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"using Logging\nsim_ida = Simulation(\n ResidualModel,\n sys, #system\n pwd(),\n (0.0, 20.0), #time span\n BranchTrip(1.0, Line, \"CORONADO -1101-PALOVRDE -1401-i_10\");\n console_level = Logging.Info,\n)","category":"page"},{"location":"tutorials/tutorial_240bus/#Run-the-simulation-using-Sundials","page":"240 WECC solver comparison","title":"Run the simulation using Sundials","text":"","category":"section"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"We will now run the simulation using Sundials.jl solver IDA() by specifying the maximum dt we want for the simulation. In our experience with this solver, solution times are faster when supplying information about the maximum time step than the tolerances as we can see in the example","category":"page"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"execute!(sim_ida, IDA(), dtmax = 0.01)","category":"page"},{"location":"tutorials/tutorial_240bus/#Read-the-results-and-plot-a-system-variable","page":"240 WECC solver comparison","title":"Read the results and plot a system variable","text":"","category":"section"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"After the simulation is completed, we can extract the results and make plots as desired. In this case, we will plot the voltage magnitude at the bus at which the line was connected.","category":"page"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"res_ida = read_results(sim_ida)\nv1101_ida = get_voltage_magnitude_series(res_ida, 1101);\nplot(v1101_ida);","category":"page"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"(Image: plot)","category":"page"},{"location":"tutorials/tutorial_240bus/#Run-the-simulation-using-Rodas4()","page":"240 WECC solver comparison","title":"Run the simulation using Rodas4()","text":"","category":"section"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"In this case, we will use a MassMatrixModel formulation, for more details about the formulation checkout the Models Section in PowerSimulationsDynamics.jl documentation","category":"page"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"sim_rodas = Simulation(\n MassMatrixModel,\n sys, #system\n pwd(),\n (0.0, 20.0), #time span\n BranchTrip(1.0, Line, \"CORONADO -1101-PALOVRDE -1401-i_10\");\n console_level = Logging.Info,\n)","category":"page"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"We will now run the simulation using OrdinaryDiffEq.jl solver Rodas4() by specifying the tolerance we want for the simulation. In our experience with this solver, solution times are faster when supplying information about the atol and rtol values as we can see in the example. The solver will also work with a specified dtmax but take a significantly longer time to solve. When using OrdinaryDiffEq.jl solvers always pass the option initializealg = NoInit() to avoid unnecessary re-initialization of the algebraic equations.","category":"page"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"execute!(\n sim_rodas,\n Rodas4(),\n saveat = 0.01,\n atol = 1e-10,\n rtol = 1e-10,\n initializealg = NoInit(),\n)","category":"page"},{"location":"tutorials/tutorial_240bus/#Read-the-results","page":"240 WECC solver comparison","title":"Read the results","text":"","category":"section"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"After the simulation is completed, we can extract the results and make plots as desired. In this case, we will plot the voltage magnitude at the bus at which the line was connected.","category":"page"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"res_rodas = read_results(sim_rodas)","category":"page"},{"location":"tutorials/tutorial_240bus/#Compare-the-results","page":"240 WECC solver comparison","title":"Compare the results","text":"","category":"section"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"After the simulation is completed, we can extract the results and make plots as desired. In this case, we will plot the voltage magnitude at the bus at which the line was connected. For both of the solution techniques.","category":"page"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"v1101 = get_voltage_magnitude_series(res_rodas, 1101);\nplot(v1101, label = \"RODAS4\");\nplot!(v1101_ida, label = \"IDA\");","category":"page"},{"location":"tutorials/tutorial_240bus/","page":"240 WECC solver comparison","title":"240 WECC solver comparison","text":"(Image: plot)","category":"page"},{"location":"component_models/freq_esti/#Frequency-Estimators","page":"Frequency Estimators","title":"Frequency Estimators","text":"","category":"section"},{"location":"component_models/freq_esti/","page":"Frequency Estimators","title":"Frequency Estimators","text":"This component is used to estimate the frequency of the grid based on the voltage at the bus.","category":"page"},{"location":"component_models/freq_esti/#Fixed-Frequency-[FixedFrequency]","page":"Frequency Estimators","title":"Fixed Frequency [FixedFrequency]","text":"","category":"section"},{"location":"component_models/freq_esti/","page":"Frequency Estimators","title":"Frequency Estimators","text":"This is a simple model that set the measured frequency to a desired constant value (i.e. does not measure the frequency) omega_pll = omega_textfix (usually omega_textfix = 10 p.u.). Used by default when grid-forming inverters do not use frequency estimators. ","category":"page"},{"location":"component_models/freq_esti/#Phase-Locked-Loop-(PLL)-for-VSM-[KauraPLL]","page":"Frequency Estimators","title":"Phase-Locked Loop (PLL) for VSM [KauraPLL]","text":"","category":"section"},{"location":"component_models/freq_esti/","page":"Frequency Estimators","title":"Frequency Estimators","text":"The following equations present a PLL used to estimate the frequency and PLL angle of the grid. There are two reference frames considered in this inverter. Those are the VSM of the outer-loop control theta_textolc and the PLL one theta_textpll. The notation used a deltatheta refers as the variation of the respective angle theta^textgrid with respect to the grid SRF (instead of the fixed alpha component of the alphabeta transformation):","category":"page"},{"location":"component_models/freq_esti/","page":"Frequency Estimators","title":"Frequency Estimators","text":"beginalign\n\ndotv_dtextpll = omega_textlp left v_dtextout - v_dtextpll right tag1a \ndotv_qtextpll = omega_textlp left v_qtextout - v_qtextpll right tag1b \ndotvarepsilon_textpll = tan^-1left(fracv_qtextpllv_dtextpll right) tag1c \ndottheta_textpll = Omega_b delta omega_textpll tag1d\nendalign","category":"page"},{"location":"component_models/freq_esti/","page":"Frequency Estimators","title":"Frequency Estimators","text":"with","category":"page"},{"location":"component_models/freq_esti/","page":"Frequency Estimators","title":"Frequency Estimators","text":"beginalign\ndeltaomega_textpll = 10 - omega_textsys + k_ptextpll tan^-1 left(fracv_qtextpllv_dtextpll right) + k_itextpll varepsilon_textpll tag1e \nomega_textpll = deltaomega_textpll + omega_textsys tag1f \nv_dtextout + jv_qtextout = (v_r + jv_i)e^-deltatheta_textpll tag1g\nendalign","category":"page"},{"location":"component_models/freq_esti/","page":"Frequency Estimators","title":"Frequency Estimators","text":"on which v_r + jv_i is the voltage in the grid reference frame on which the PLL is measuring (i.e. point of common coupling), that could be in the capacitor of an LCL filter or the last branch of such filter.","category":"page"},{"location":"component_models/freq_esti/#Reduced-Order-Phase-Locked-Loop-(PLL)-[ReducedOrderPLL]","page":"Frequency Estimators","title":"Reduced Order Phase-Locked Loop (PLL) [ReducedOrderPLL]","text":"","category":"section"},{"location":"component_models/freq_esti/","page":"Frequency Estimators","title":"Frequency Estimators","text":"The following equations presents a simplified PLL used to estimate the frequency and PLL angle of the grid. The model attempts to steer the voltage in the q-axis to zero (i.e. lock the q-axis to zero) using a PI controller. With that the equations are given by:","category":"page"},{"location":"component_models/freq_esti/","page":"Frequency Estimators","title":"Frequency Estimators","text":"beginalign\ndotv_qtextpll = omega_textlp left v_qtextout - v_qtextpll right tag2a \ndotvarepsilon_textpll = v_qtextpll tag2b \ndottheta_textpll = Omega_b delta omega_textpll tag2c\nendalign","category":"page"},{"location":"component_models/freq_esti/","page":"Frequency Estimators","title":"Frequency Estimators","text":"with","category":"page"},{"location":"component_models/freq_esti/","page":"Frequency Estimators","title":"Frequency Estimators","text":"beginalign\ndeltaomega_textpll = 10 - omega_textsys + k_ptextpll v_qtextpll + k_itextpll varepsilon_textpll tag2d \nomega_textpll = deltaomega_textpll + omega_textsys tag2e \nv_dtextout + jv_qtextout = (v_r + jv_i)e^-deltatheta_textpll tag2f\nendalign","category":"page"},{"location":"component_models/freq_esti/","page":"Frequency Estimators","title":"Frequency Estimators","text":"on which v_r + jv_i is the voltage in the grid reference frame on which the PLL is measuring (i.e. point of common coupling), that could be in the capacitor of an LCL filter or the last branch of such filter.","category":"page"},{"location":"code_base_developer_guide/developer/#Guidelines-for-Developers","page":"Developer Guide","title":"Guidelines for Developers","text":"","category":"section"},{"location":"code_base_developer_guide/developer/","page":"Developer Guide","title":"Developer Guide","text":"In order to contribute to PowerSimulationsDynamics.jl repository please read the following sections of InfrastructureSystems.jl documentation in detail:","category":"page"},{"location":"code_base_developer_guide/developer/","page":"Developer Guide","title":"Developer Guide","text":"Style Guide\nContributing Guidelines","category":"page"},{"location":"code_base_developer_guide/developer/","page":"Developer Guide","title":"Developer Guide","text":"Pull requests are always welcome to fix bugs or add additional modeling capabilities.","category":"page"},{"location":"code_base_developer_guide/developer/","page":"Developer Guide","title":"Developer Guide","text":"All the code contributions need to include tests with a minimum coverage of 70%","category":"page"},{"location":"tutorials/tutorial_dynamic_data/#Creating-and-Handling-Data-for-Dynamic-Simulations","page":"Create Dynamic Data","title":"Creating and Handling Data for Dynamic Simulations","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"Originally Contributed by: Rodrigo Henriquez and José Daniel Lara","category":"page"},{"location":"tutorials/tutorial_dynamic_data/#Introduction","page":"Create Dynamic Data","title":"Introduction","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"This tutorial briefly introduces how to create a system using PowerSystems.jl data structures. For more details visit PowerSystems.jl Documentation","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"Start by calling PowerSystems.jl and PowerSystemCaseBuilder.jl:","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"using PowerSystems\nusing PowerSystemCaseBuilder\nconst PSY = PowerSystems;","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"note: Note\nPowerSystemCaseBuilder.jl is a helper library that makes it easier to reproduce examples in the documentation and tutorials. Normally you would pass your local files to create the system data instead of calling the function build_system. For more details visit PowerSystemCaseBuilder Documentation","category":"page"},{"location":"tutorials/tutorial_dynamic_data/#System-description","page":"Create Dynamic Data","title":"System description","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"Next we need to define the different elements required to run a simulation. To run a simulation in PowerSimulationsDynamics, it is required to define a System that contains the following components:","category":"page"},{"location":"tutorials/tutorial_dynamic_data/#Static-Components","page":"Create Dynamic Data","title":"Static Components","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"We called static components to those that are used to run a Power Flow problem.","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"Vector of Bus elements, that define all the buses in the network.\nVector of Branch elements, that define all the branches elements (that connect two buses) in the network.\nVector of StaticInjection elements, that define all the devices connected to buses that can inject (or withdraw) power. These static devices, typically generators, in PowerSimulationsDynamics are used to solve the Power Flow problem that determines the active and reactive power provided for each device.\nVector of PowerLoad elements, that define all the loads connected to buses that can withdraw current. These are also used to solve the Power Flow.\nVector of Source elements, that define source components behind a reactance that can inject or withdraw current.\nThe base of power used to define per unit values, in MVA as a Float64 value.\nThe base frequency used in the system, in Hz as a Float64 value.","category":"page"},{"location":"tutorials/tutorial_dynamic_data/#Dynamic-Components","page":"Create Dynamic Data","title":"Dynamic Components","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"Dynamic components are those that define differential equations to run a transient simulation.","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"Vector of DynamicInjection elements. These components must be attached to a StaticInjection that connects the power flow solution to the dynamic formulation of such device. DynamicInjection can be DynamicGenerator or DynamicInverter, and its specific formulation (i.e. differential equations) will depend on the specific components that define such device.\n(Optional) Selecting which of the Lines (of the Branch vector) elements must be modeled of DynamicLines elements, that can be used to model lines with differential equations.","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"To start we will define the data structures for the network.","category":"page"},{"location":"tutorials/tutorial_dynamic_data/#Three-Bus-case-manual-data-creation","page":"Create Dynamic Data","title":"Three Bus case manual data creation","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"The following describes the system creation for this dynamic simulation case.","category":"page"},{"location":"tutorials/tutorial_dynamic_data/#Static-System-creation","page":"Create Dynamic Data","title":"Static System creation","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"To create the system you need to load data using PowerSystemCaseBuilder.jl. This system was originally created from following raw file. ","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"sys = build_system(PSIDSystems, \"3 Bus Inverter Base\"; force_build=true)","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"This system does not have an injection device in bus 1 (the reference bus). We can add a source with small impedance directly as follows:","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"slack_bus = [b for b in get_components(ACBus, sys) if get_bustype(b) == ACBusTypes.REF][1]\ninf_source = Source(\n name = \"InfBus\", #name\n available = true, #availability\n active_power = 0.0,\n reactive_power = 0.0,\n bus = slack_bus, #bus\n R_th = 0.0, #Rth\n X_th = 5e-6, #Xth\n)\nadd_component!(sys, inf_source)","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"We just added a infinite source with X_th = 5cdot 10^-6 pu. The system can be explored directly using functions like:","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"show_components(sys, Source)","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"show_components(sys, ThermalStandard)","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"By exploring those it can be seen that the generators are named as: generator-bus_number-id. Then, the generator attached at bus 2 is named generator-102-1.","category":"page"},{"location":"tutorials/tutorial_dynamic_data/#Dynamic-Injections","page":"Create Dynamic Data","title":"Dynamic Injections","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"We are now interested in attaching to the system the dynamic component that will be modeling our dynamic generator.","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"Dynamic generator devices are composed by 5 components, namely, machine, shaft, avr, tg and pss. So we will be adding functions to create all of its components and the generator itself:","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"# *Machine*\nmachine_classic() = BaseMachine(\n 0.0, #R\n 0.2995, #Xd_p\n 0.7087, #eq_p\n)\n\n# *Shaft*\nshaft_damping() = SingleMass(\n 3.148, #H\n 2.0, #D\n)\n\n# *AVR: No AVR*\navr_none() = AVRFixed(0.0)\n\n# *TG: No TG*\ntg_none() = TGFixed(1.0) #efficiency\n\n# *PSS: No PSS*\npss_none() = PSSFixed(0.0)","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"The next lines receives a static generator name, and creates a DynamicGenerator based on that specific static generator, with the specific components defined previously. This is a classic machine model without AVR, Turbine Governor and PSS.","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"static_gen = get_component(Generator, sys, \"generator-102-1\")\n\ndyn_gen = DynamicGenerator(\n name = get_name(static_gen),\n ω_ref = 1.0,\n machine = machine_classic(),\n shaft = shaft_damping(),\n avr = avr_none(),\n prime_mover = tg_none(),\n pss = pss_none(),\n)","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"The dynamic generator is added to the system by specifying the dynamic and static generator","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"add_component!(sys, dyn_gen, static_gen)","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"Then we can serialize our system data to a json file that can be later read as:","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"file_dir = @__DIR__ #hide\nto_json(sys, joinpath(file_dir, \"modified_sys.json\"), force = true)","category":"page"},{"location":"tutorials/tutorial_dynamic_data/#Dynamic-Lines-case:-Data-creation","page":"Create Dynamic Data","title":"Dynamic Lines case: Data creation","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"We will now create a three bus system with one inverter and one generator. In order to do so, we will parse the following ThreebusInverter.raw network:","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"threebus_sys = build_system(PSIDSystems, \"3 Bus Inverter Base\")\nslack_bus = first(get_components(x -> get_bustype(x) == BusTypes.REF, Bus, threebus_sys))\ninf_source = Source(\n name = \"InfBus\", #name\n available = true, #availability\n active_power = 0.0,\n reactive_power = 0.0,\n bus = slack_bus, #bus\n R_th = 0.0, #Rth\n X_th = 5e-6, #Xth\n)\nadd_component!(threebus_sys, inf_source)","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"We will connect a One-d-one-q machine at bus 102, and a Virtual Synchronous Generator Inverter at bus 103. An inverter is composed by a converter, outer control, inner control, dc source, frequency estimator and a filter.","category":"page"},{"location":"tutorials/tutorial_dynamic_data/#Dynamic-Inverter-definition","page":"Create Dynamic Data","title":"Dynamic Inverter definition","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"We will create specific functions to create the components of the inverter as follows:","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"#Define converter as an AverageConverter\nconverter_high_power() = AverageConverter(\n rated_voltage = 138.0,\n rated_current = 100.0\n )\n\n#Define Outer Control as a composition of Virtual Inertia + Reactive Power Droop\nouter_control() = OuterControl(\n VirtualInertia(Ta = 2.0, kd = 400.0, kω = 20.0),\n ReactivePowerDroop(kq = 0.2, ωf = 1000.0),\n)\n\n#Define an Inner Control as a Voltage+Current Controler with Virtual Impedance:\ninner_control() = VoltageModeControl(\n kpv = 0.59, #Voltage controller proportional gain\n kiv = 736.0, #Voltage controller integral gain\n kffv = 0.0, #Binary variable enabling voltage feed-forward in current controllers\n rv = 0.0, #Virtual resistance in pu\n lv = 0.2, #Virtual inductance in pu\n kpc = 1.27, #Current controller proportional gain\n kic = 14.3, #Current controller integral gain\n kffi = 0.0, #Binary variable enabling the current feed-forward in output of current controllers\n ωad = 50.0, #Active damping low pass filter cut-off frequency\n kad = 0.2, #Active damping gain\n)\n\n#Define DC Source as a FixedSource:\ndc_source_lv() = FixedDCSource(voltage = 600.0)\n\n#Define a Frequency Estimator as a PLL\n#based on Vikram Kaura and Vladimir Blaskoc 1997 paper:\npll() = KauraPLL(\n ω_lp = 500.0, #Cut-off frequency for LowPass filter of PLL filter.\n kp_pll = 0.084, #PLL proportional gain\n ki_pll = 4.69, #PLL integral gain\n)\n\n#Define an LCL filter:\nfilt() = LCLFilter(lf = 0.08, rf = 0.003, cf = 0.074, lg = 0.2, rg = 0.01)","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"We will construct the inverter later by specifying to which static device is assigned.","category":"page"},{"location":"tutorials/tutorial_dynamic_data/#Dynamic-Generator-definition","page":"Create Dynamic Data","title":"Dynamic Generator definition","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"Similarly we will construct a dynamic generator as follows:","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"# Create the machine\nmachine_oneDoneQ() = OneDOneQMachine(\n 0.0, #R\n 1.3125, #Xd\n 1.2578, #Xq\n 0.1813, #Xd_p\n 0.25, #Xq_p\n 5.89, #Td0_p\n 0.6, #Tq0_p\n)\n\n# Shaft\nshaft_no_damping() = SingleMass(\n 3.01, #H (M = 6.02 -> H = M/2)\n 0.0, #D\n)\n\n# AVR: Type I: Resembles a DC1 AVR\navr_type1() = AVRTypeI(\n 20.0, #Ka - Gain\n 0.01, #Ke\n 0.063, #Kf\n 0.2, #Ta\n 0.314, #Te\n 0.35, #Tf\n 0.001, #Tr\n (min = -5.0, max = 5.0),\n 0.0039, #Ae - 1st ceiling coefficient\n 1.555, #Be - 2nd ceiling coefficient\n)\n\n#No TG\ntg_none() = TGFixed(1.0) #efficiency\n\n#No PSS\npss_none() = PSSFixed(0.0) #Vs","category":"page"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"Now we will construct the dynamic generator and inverter.","category":"page"},{"location":"tutorials/tutorial_dynamic_data/#Add-the-components-to-the-system","page":"Create Dynamic Data","title":"Add the components to the system","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"for g in get_components(Generator, threebus_sys)\n #Find the generator at bus 102\n if get_number(get_bus(g)) == 102\n #Create the dynamic generator\n case_gen = DynamicGenerator(\n get_name(g),\n 1.0, # ω_ref,\n machine_oneDoneQ(), #machine\n shaft_no_damping(), #shaft\n avr_type1(), #avr\n tg_none(), #tg\n pss_none(), #pss\n )\n #Attach the dynamic generator to the system by\n # specifying the dynamic and static components\n add_component!(threebus_sys, case_gen, g)\n #Find the generator at bus 103\n elseif get_number(get_bus(g)) == 103\n #Create the dynamic inverter\n case_inv = DynamicInverter(\n get_name(g),\n 1.0, # ω_ref,\n converter_high_power(), #converter\n outer_control(), #outer control\n inner_control(), #inner control voltage source\n dc_source_lv(), #dc source\n pll(), #pll\n filt(), #filter\n )\n #Attach the dynamic inverter to the system\n add_component!(threebus_sys, case_inv, g)\n end\nend","category":"page"},{"location":"tutorials/tutorial_dynamic_data/#Save-the-system-in-a-JSON-file","page":"Create Dynamic Data","title":"Save the system in a JSON file","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_data/","page":"Create Dynamic Data","title":"Create Dynamic Data","text":"file_dir = @__DIR__ #hide\nto_json(threebus_sys, joinpath(file_dir, \"threebus_sys.json\"), force = true)","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/#Line-Modeling-Simulations","page":"Dynamic Lines Simulation","title":"Line Modeling Simulations","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"Originally Contributed by: Rodrigo Henriquez-Auba and José Daniel Lara","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/#Introduction","page":"Dynamic Lines Simulation","title":"Introduction","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"This tutorial will introduce an example of considering dynamic lines in PowerSimulationsDynamics.","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"This tutorial presents a simulation of a three-bus system, with an infinite bus (represented as a voltage source behind an impedance) at bus 1, a one d- one q- machine on bus 2 and an inverter of 19 states, as a virtual synchronous machine at bus 3. The perturbation will be the trip of two of the three circuits (triplicating its resistance and impedance) of the line that connects bus 1 and bus 3. This case also consider a dynamic line model for connection between buses 2 and 3. We will compare it against a system without dynamic lines.","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"It is recommended to check the OMIB tutorial first, since that includes more details and explanations on all definitions and functions.","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/#Step-1:-Package-Initialization","page":"Dynamic Lines Simulation","title":"Step 1: Package Initialization","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"using PowerSimulationsDynamics\nusing PowerSystems\nusing PowerNetworkMatrices\nusing PowerSystemCaseBuilder\nusing Sundials\nusing Plots","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"note: Note\nPowerSystemCaseBuilder.jl is a helper library that makes it easier to reproduce examples in the documentation and tutorials. Normally you would pass your local files to create the system data instead of calling the function build_system. For more details visit PowerSystemCaseBuilder Documentation","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/#Step-2:-Data-creation","page":"Dynamic Lines Simulation","title":"Step 2: Data creation","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"Load the system using PowerSystemCaseBuilder.jl:","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"threebus_sys = build_system(PSIDSystems, \"Three Bus Dynamic data Example System\")","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"In addition, we will create a new copy of the system on which we will simulate the same case, but will consider dynamic lines:","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"threebus_sys_dyn = deepcopy(threebus_sys);","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/#Step-3:-Create-the-fault-and-simulation-on-the-Static-Lines-system","page":"Dynamic Lines Simulation","title":"Step 3: Create the fault and simulation on the Static Lines system","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"First, we construct the perturbation, by properly computing the new Ybus on the system:","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"#Make a copy of the original system\nsys2 = deepcopy(threebus_sys)\n#Triplicates the impedance of the line named \"BUS 1-BUS 3-i_1\"\nfault_branches = get_components(ACBranch, sys2)\nfor br in fault_branches\n if get_name(br) == \"BUS 1-BUS 3-i_1\"\n br.r = 3 * br.r\n br.x = 3 * br.x\n b_new = (from = br.b.from / 3, to = br.b.to / 3)\n br.b = b_new\n end\nend\n#Obtain the new Ybus\nYbus_fault = Ybus(sys2).data\n#Define Fault: Change of YBus\nYbus_change = NetworkSwitch(\n 1.0, #change at t = 1.0\n Ybus_fault, #New YBus\n);","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"Now, we construct the simulation:","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"#Time span of our simulation\ntspan = (0.0, 30.0)\n\n#Define Simulation\nsim = Simulation(\n ResidualModel, #Type of model used\n threebus_sys, #system\n pwd(), #folder to output results\n tspan, #time span\n Ybus_change, #Type of perturbation\n)","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"We can obtain the initial conditions as:","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"#Print the initial states. It also give the symbols used to describe those states.\nshow_states_initial_value(sim)","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/#Step-4:-Run-the-simulation-of-the-Static-Lines-System","page":"Dynamic Lines Simulation","title":"Step 4: Run the simulation of the Static Lines System","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"#Run the simulation\nexecute!(\n sim, #simulation structure\n IDA(), #Sundials DAE Solver\n dtmax = 0.02, #Maximum step size\n)","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/#Step-5:-Store-the-solution","page":"Dynamic Lines Simulation","title":"Step 5: Store the solution","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"results = read_results(sim)\nseries2 = get_voltage_magnitude_series(results, 102)\nzoom = [\n (series2[1][ix], series2[2][ix]) for\n (ix, s) in enumerate(series2[1]) if (s > 0.90 && s < 1.6)\n];","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/#Step-3.1:-Create-the-fault-and-simulation-on-the-Dynamic-Lines-system","page":"Dynamic Lines Simulation","title":"Step 3.1: Create the fault and simulation on the Dynamic Lines system","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"An important aspect to consider is that DynamicLines must not be considered in the computation of the Ybus. First we construct the Dynamic Line, by finding the Line named \"BUS 2-BUS 3-i_1\", and then adding it to the system.","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"# get component return the Branch on threebus_sys_dyn named \"BUS 2-BUS 3-i_1\"\ndyn_branch = DynamicBranch(get_component(Line, threebus_sys_dyn,\"BUS 2-BUS 3-i_1\"))\n# Adding a dynamic line will immediately remove the static line from the system.\nadd_component!(threebus_sys_dyn, dyn_branch)","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"Similarly, we construct the Ybus fault by creating a copy of the original system, but removing the Line \"BUS 2-BUS 3-i_1\" to avoid considering it in the Ybus:","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"#Make a copy of the original system\nsys3 = deepcopy(threebus_sys);\n#Remove Line \"BUS 2-BUS 3-i_1\"\nremove_component!(Line, sys3, \"BUS 2-BUS 3-i_1\")\n#Triplicates the impedance of the line named \"BUS 1-BUS 2-i_1\"\nfault_branches2 = get_components(Line, sys3)\nfor br in fault_branches2\n if get_name(br) == \"BUS 1-BUS 3-i_1\"\n br.r = 3 * br.r\n br.x = 3 * br.x\n b_new = (from = br.b.from / 3, to = br.b.to / 3)\n br.b = b_new\n end\nend\n#Obtain the new Ybus\nYbus_fault_dyn = Ybus(sys3).data\n#Define Fault: Change of YBus\nYbus_change_dyn = NetworkSwitch(\n 1.0, #change at t = 1.0\n Ybus_fault_dyn, #New YBus\n)","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/#Step-4.1:-Run-the-simulation-of-the-Dynamic-Lines-System","page":"Dynamic Lines Simulation","title":"Step 4.1: Run the simulation of the Dynamic Lines System","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"Now, we construct the simulation:","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"# Define Simulation\nsim_dyn = Simulation(\n ResidualModel, #Type of model used\n threebus_sys_dyn, #system\n pwd(), #folder to output results\n (0.0, 30.0), #time span\n Ybus_change_dyn, #Type of perturbation\n)","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"# Run the simulation\nexecute!(\n sim_dyn, #simulation structure\n IDA(), #Sundials DAE Solver\n dtmax = 0.02, #Maximum step size\n)","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"We can obtain the initial conditions as:","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"#Print the initial states. It also give the symbols used to describe those states.\nshow_states_initial_value(sim_dyn)","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/#Step-5.1:-Store-the-solution","page":"Dynamic Lines Simulation","title":"Step 5.1: Store the solution","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"results_dyn = read_results(sim_dyn)\nseries2_dyn = get_voltage_magnitude_series(results_dyn, 102);\nzoom_dyn = [\n (series2_dyn[1][ix], series2_dyn[2][ix]) for\n (ix, s) in enumerate(series2_dyn[1]) if (s > 0.90 && s < 1.6)\n];","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/#Step-6.1:-Compare-the-solutions:","page":"Dynamic Lines Simulation","title":"Step 6.1: Compare the solutions:","text":"","category":"section"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"We can observe the effect of Dynamic Lines","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"plot(series2_dyn, label = \"V_gen_dyn\");\nplot!(series2, label = \"V_gen_st\", xlabel = \"Time [s]\", ylabel = \"Voltage [pu]\");","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"(Image: plot)","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"that looks quite similar. The differences can be observed in the zoom plot:","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"plot(zoom_dyn, label = \"V_gen_dyn\");\nplot!(zoom, label = \"V_gen_st\", xlabel = \"Time [s]\", ylabel = \"Voltage [pu]\");","category":"page"},{"location":"tutorials/tutorial_dynamic_lines/","page":"Dynamic Lines Simulation","title":"Dynamic Lines Simulation","text":"(Image: plot)","category":"page"},{"location":"models/#Models","page":"Models","title":"Models","text":"","category":"section"},{"location":"models/#Simulation-Models","page":"Models","title":"Simulation Models","text":"","category":"section"},{"location":"models/","page":"Models","title":"Models","text":"PowerSimulations dynamics supports two formulations for the simulation model and define different methods for each simulation model. You can pass ResidualModel or MassMatrixModel to a call to Simulation to define the preferred formulation.","category":"page"},{"location":"models/","page":"Models","title":"Models","text":"In this way, we provide a common set of development requirements for contributors of new models that maintains the same flexibility in choosing the solving algorithm.","category":"page"},{"location":"models/","page":"Models","title":"Models","text":"MassMatrixModel: Defines models that can be solved using Mass-Matrix Solvers. The model is formulated as follows:","category":"page"},{"location":"models/","page":"Models","title":"Models","text":"beginalign\nMfracdx(t)dt = f(x(t))\nendalign","category":"page"},{"location":"models/","page":"Models","title":"Models","text":"At this stage we have not conducted extensive tests with all the solvers in DifferentialEquations most of our tests use Rodas5().","category":"page"},{"location":"models/","page":"Models","title":"Models","text":"ResidualModel: Define models that can be solved using Implicit ODE solvers and also the solver IDA from Sundials. The model is formulated to solved the following problem:","category":"page"},{"location":"models/","page":"Models","title":"Models","text":"beginalign\nr(t) = fracdx(t)dt - f(x(t))\nendalign","category":"page"},{"location":"models/","page":"Models","title":"Models","text":"At this stage we have not conducted extensive tests with all the solvers in DifferentialEquations if you are solving a larger system use IDA().","category":"page"},{"location":"models/#The-dynamic-system-model-in-PowerSimulationsDynamics","page":"Models","title":"The dynamic system model in PowerSimulationsDynamics","text":"","category":"section"},{"location":"models/","page":"Models","title":"Models","text":"In order to support both formulations, the default implementation of the ResidualModel solves the following problem:","category":"page"},{"location":"models/","page":"Models","title":"Models","text":"beginalign\nr(t) = Mfracdx(t)dt - f(x(t))\nendalign","category":"page"},{"location":"models/#Solution-approaches","page":"Models","title":"Solution approaches","text":"","category":"section"},{"location":"models/","page":"Models","title":"Models","text":"PowerSimulationsDynamics.jl construct the entire function that is passed to DifferentialEquations to solve it using different solvers. This is called the Simultaneous-solution approach to numerically integrate over time. It gives the user the flexibility to model devices with a combination of differential and algebraic states. In addition, it gives the flexibility to model the network using an algebraic or differential model.","category":"page"},{"location":"models/","page":"Models","title":"Models","text":"On the other hand, industrial tools such as PSS/E uses a Partitioned-solution approach, on which the network must be modeled using an algebraic approach, and the differential equations and algebraic equations are solved sequentially. This method is usually faster if the heuristics for convergence when solving sequentially are properly tuned. However, boundary techniques must be considered when the connection with the devices and network is not converging when applying the partitioned-solution approach.","category":"page"},{"location":"models/","page":"Models","title":"Models","text":"The difference in solution methods can complicate the validation and comparison between software tools. In addition it can affect the computational properties due to reliance of heuristics. These solution aspects are important to consider when using different tools for simulating power systems dynamics.","category":"page"},{"location":"models/","page":"Models","title":"Models","text":"For more details, check Brian Stott paper \"Power system dynamic response calculations\".","category":"page"},{"location":"models/#Generator-Models","page":"Models","title":"Generator Models","text":"","category":"section"},{"location":"models/","page":"Models","title":"Models","text":"Here we discuss the structure and models used to model generators in PowerSimulationsDynamics.jl. See PowerSystems.jl dynamic devices for details.","category":"page"},{"location":"models/","page":"Models","title":"Models","text":"Each generator is a data structure composed of the following components defined in PowerSystems.jl:","category":"page"},{"location":"models/","page":"Models","title":"Models","text":"Machine: That defines the stator electro-magnetic dynamics.\nShaft: That describes the rotor electro-mechanical dynamics.\nAutomatic Voltage Regulator: Electromotive dynamics to model an AVR controller.\nPower System Stabilizer: Control dynamics to define an stabilization signal for the AVR.\nPrime Mover and Turbine Governor: Thermo-mechanical dynamics and associated controllers.","category":"page"},{"location":"models/","page":"Models","title":"Models","text":"The implementation of Synchronous generators as components uses the following structure to share values across components.","category":"page"},{"location":"models/","page":"Models","title":"Models","text":"","category":"page"},{"location":"models/#Inverter-Models","page":"Models","title":"Inverter Models","text":"","category":"section"},{"location":"models/","page":"Models","title":"Models","text":"Here we discuss the structure and models used to model inverters in PowerSimulationsDynamics.jl. See PowerSystems.jl dynamic devices for details. One of the key contributions in this software package is a separation of the components in a way that resembles current practices for synchronoues machine modeling.","category":"page"},{"location":"models/","page":"Models","title":"Models","text":"DC Source: Defines the dynamics of the DC side of the converter.\nFrequency Estimator: That describes how the frequency of the grid can be estimated using the grid voltages. Typically a phase-locked loop (PLL).\nOuter Loop Control: That describes the active and reactive power control dynamics.\nInner Loop Control: That can describe virtual impedance, voltage control and current control dynamics.\nConverter: That describes the dynamics of the pulse width modulation (PWM) or space vector modulation (SVM).\nFilter: Used to connect the converter output to the grid.","category":"page"},{"location":"models/","page":"Models","title":"Models","text":"The following figure summarizes the components of a inverter and which variables they share:","category":"page"},{"location":"models/","page":"Models","title":"Models","text":"","category":"page"},{"location":"models/","page":"Models","title":"Models","text":"Contrary to the generator, there are many control structures that can be used to model inverter controllers (e.g. grid-following, grid feeding or virtual synchronous machine). For this purpose, more variables are shared among the components in order to cover all these posibilities.","category":"page"},{"location":"models/#Reference","page":"Models","title":"Reference","text":"","category":"section"},{"location":"models/","page":"Models","title":"Models","text":"For models, check the library in PowerSystems.jl","category":"page"},{"location":"component_models/avr/#Automatic-Voltage-Regulators-(AVR)","page":"AVR","title":"Automatic Voltage Regulators (AVR)","text":"","category":"section"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"AVR are used to determine the voltage in the field winding v_f (or V_f) in the model.","category":"page"},{"location":"component_models/avr/#Fixed-AVR-[AVRFixed]","page":"AVR","title":"Fixed AVR [AVRFixed]","text":"","category":"section"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"This is a simple model that set the field voltage to be equal to a desired constant value v_f = v_textfix.","category":"page"},{"location":"component_models/avr/#Simple-AVR-[AVRSimple]","page":"AVR","title":"Simple AVR [AVRSimple]","text":"","category":"section"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"This depicts the most basic AVR, on which the field voltage is an integrator over the difference of the measured voltage and a reference:","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"beginalign\ndotv_f = K_v(v_textref - v_h) tag1a\nendalign","category":"page"},{"location":"component_models/avr/#AVR-Type-I-[AVRTypeI]","page":"AVR","title":"AVR Type I [AVRTypeI]","text":"","category":"section"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"This AVR is a simplified version of the IEEE DC1 AVR model:","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"beginalign\ndotv_f = -frac1T_e left V_f(K_e + S_e(v_f))-v_r1 right tag2a \ndotv_r1 = frac1T_a left K_aleft(v_textref - v_m - v_r2 - fracK_fT_fv_fright) - v_r1 right tag2b \ndotv_r2 = -frac1T_f left fracK_fT_fv_f + v_r2 right tag2c \ndotv_m = frac1T_r (v_h - v_m) tag2d\nendalign","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"with the ceiling function:","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"beginalign*\nS_e(v_f) = A_e exp(B_ev_f)\nendalign*","category":"page"},{"location":"component_models/avr/#AVR-Type-II-[AVRTypeII]","page":"AVR","title":"AVR Type II [AVRTypeII]","text":"","category":"section"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"This model represents a static exciter with higher gains and faster response than the Type I:","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"beginalign\ndotv_f = -frac1T_e left V_f(1 + S_e(v_f))-v_r right tag3a \ndotv_r1 = frac1T_1 left K_0left(1 - fracT_2T_1 right)(v_textref - v_m) - v_r1 right tag3b \ndotv_r2 = frac1K_0 T_3 left left( 1 - fracT_4T_3 right) left( v_r1 + K_0fracT_2T_1(v_textref - v_m)right) - K_0 v_r2 right tag3c \ndotv_m = frac1T_r (v_h - v_m) tag3d\nendalign","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"with","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"beginalign*\nv_r = K_0v_r2 + fracT_4T_3 left( v_r1 + K_0fracT_2T_1(v_textref - v_m)right) \nS_e(v_f) = A_e exp(B_ev_f)\nendalign*","category":"page"},{"location":"component_models/avr/#Excitation-System-AC1A-[ESAC1A]","page":"AVR","title":"Excitation System AC1A [ESAC1A]","text":"","category":"section"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"The model represents the 5-states IEEE Type AC1A Excitation System Model:","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"beginalign\ndotV_m = frac1T_r (V_h - V_m) tag4a \ndotV_r1 = frac1T_b left(V_in left(1 - fracT_cT_bright) - V_r1right) tag4b \ndotV_r2 = frac1T_a (K_a V_out - V_r2) tag4c \ndotV_e = frac1T_e (V_r - V_FE) tag4d \ndotV_r3 = frac1T_f left( - fracK_fT_fV_FE - V_r3 right) tag4e \nendalign","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"with","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"beginalign*\nI_N = fracK_cV_e X_adI_fd \nV_FE = K_d X_adI_fd + K_e V_e + S_e V_e \nS_e = Bfrac(V_e-A)^2V_e \nV_F1 = V_r3 + fracK_fT_f V_FE \nV_in = V_ref - V_m - V_F1 \nV_out = V_r1 + fracT_cT_b V_in \nV_f = V_e f(I_N) \nf(I_N) = leftbeginarraycl\n 1 text if I_N le 0 \n 1 - 0577 I_N text if 0 I_N le 0433 \n sqrt075 - I_N^2 text if 0433 I_N le 075 \n 1732(1-I_N) text if 075 I_N le 1 \n 0 text if I_N 1 endarray right\nendalign*","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"on which X_adI_fd is the field current coming from the generator and V_h is the terminal voltage, and AB are the saturation coefficients computed using the E_1 E_2 S_e(E_1) S_e(E_2) data.","category":"page"},{"location":"component_models/avr/#Simplified-Excitation-System-[SEXS]","page":"AVR","title":"Simplified Excitation System [SEXS]","text":"","category":"section"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"The model for the 2 states excitation system SEXS:","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"beginalign\ndotV_f = frac1T_e (V_LL - V_f) tag5a \ndotV_r = frac1T_b leftleft(1 - fracT_aT_bright) V_in - V_r right tag5b\nendalign","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"with","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"beginalign*\nV_in = V_ref + V_s - V_h \nV_LL = V_r + fracT_aT_bV_in \nendalign*","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"on which V_h is the terminal voltage and V_s is the PSS output signal.","category":"page"},{"location":"component_models/avr/#Excitation-System-ST1-[EXST1]","page":"AVR","title":"Excitation System ST1 [EXST1]","text":"","category":"section"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"The model represents the 4-states IEEE Type ST1 Excitation System Model:","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"beginalign\ndotV_m = frac1T_r (V_h - V_m) tag6a \ndotV_rll = frac1T_b left(V_in left(1 - fracT_cT_bright) - V_rllright) tag6b \ndotV_r = frac1T_a (V_LL - V_r) tag6c \ndotV_fb = frac1T_f left( - fracK_fT_fV_r - V_fb right) tag6d \nendalign","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"with ","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"beginalign*\nV_in = V_ref - V_m - y_hp \nV_LL = V_r + fracT_cT_b V_in \ny_hp = V_fb + fracK_fT_f V_r \nV_f = V_r \nendalign*","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"on which V_h is the terminal voltage.","category":"page"},{"location":"component_models/avr/#Excitation-System-EXAC1-[EXAC1]","page":"AVR","title":"Excitation System EXAC1 [EXAC1]","text":"","category":"section"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"The model represents the 5-states IEEE Type EXAC1 Excitation System Model:","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"beginalign\ndotV_m = frac1T_r (V_h - V_m) tag7a \ndotV_r1 = frac1T_b left(V_in left(1 - fracT_cT_bright) - V_r1right) tag7b \ndotV_r2 = frac1T_a (K_a V_out - V_r2) tag7c \ndotV_e = frac1T_e (V_r - V_FE) tag7d \ndotV_r3 = frac1T_f left( - fracK_fT_fV_FE - V_r3 right) tag7e \nendalign","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"with","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"beginalign*\nI_N = fracK_cV_e X_adI_fd \nV_FE = K_d X_adI_fd + K_e V_e + S_e V_e \nS_e = Bfrac(V_e-A)^2V_e \nV_F1 = V_r3 + fracK_fT_f V_FE \nV_in = V_ref - V_m - V_F1 \nV_out = V_r1 + fracT_cT_b V_in \nV_f = V_e f(I_N) \nf(I_N) = leftbeginarraycl\n 1 text if I_N le 0 \n 1 - 0577 I_N text if 0 I_N le 0433 \n sqrt075 - I_N^2 text if 0433 I_N le 075 \n 1732(1-I_N) text if 075 I_N le 1 \n 0 text if I_N 1 endarray right\nendalign*","category":"page"},{"location":"component_models/avr/","page":"AVR","title":"AVR","text":"on which X_adI_fd is the field current coming from the generator and V_h is the terminal voltage, and AB are the saturation coefficients computed using the E_1 E_2 S_e(E_1) S_e(E_2) data.","category":"page"},{"location":"component_models/outer_control/#Outer-Loop-Controls","page":"Outer Control","title":"Outer Loop Controls","text":"","category":"section"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"This component defines controllers for both active and reactive power. The joint design is based on the fact that many novel control techniques can be based on joint control of active and reactive power.","category":"page"},{"location":"component_models/outer_control/#Virtual-Inertia-and-Q-droop-[OuterControl]","page":"Outer Control","title":"Virtual Inertia and Q-droop [OuterControl]","text":"","category":"section"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"The following model represent a virtual synchronous machine model to represent how active power is going to be deployed. The constructor is OuterControl{VirtualInertia, ReactivePowerDroop}. It defines a new SRF denoted as theta_textolc for the active power controller and uses a simple voltage droop for dispatching reactive power:","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"beginalign\n dotomega_textolc = fracp_textrefT_a - fracp_eT_a - frack_d(omega_textolc - omega_textpll)T_a - frack_omega(omega_textolc - omega_textref)T_a tag1a \n dottheta_textolc = Omega_b (omega_textolc - omega_textsys) tag1b \n dotq_m = omega_f (q_e - q_m) tag1c\nendalign","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"with","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"beginalign\n p_e = v_ri_r + v_ii_i tag1d \n q_e = v_ii_r - v_ri_i tag1e \n v_textolc^textref = v_textref + k_q(q_textref - q_m) tag1f\nendalign","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"In this case, the measurement of power are being done in the capacitor of the LCL filter. However, depending on the model, this measurements could be different depending on where is the point of common coupling.","category":"page"},{"location":"component_models/outer_control/#Active-Power-Droop-(P-droop)-and-Q-droop-[OuterControl]","page":"Outer Control","title":"Active Power Droop (P-droop) and Q-droop [OuterControl]","text":"","category":"section"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"The following model represent a Ptext-f droop model to represent how active power is going to be deployed. The constructor is OuterControl{ActivePowerControl, ReactivePowerDroop}. It defines a new SRF denoted as theta_textolc for the active power controller and uses a simple voltage droop for dispatching reactive power. Both active and reactive power are measured via a low-pass filter:","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"beginalign\n dottheta_textolc = Omega_b (omega_textolc - omega_textsys) tag2a \n dotp_m = omega_z (p_e - p_m) tag2b \n dotq_m = omega_f (q_e - q_m) tag2c\nendalign","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"with","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"beginalign\n p_e = v_ri_r + v_ii_i tag2d \n q_e = v_ii_r - v_ri_i tag2e \n omega_textolc = omega_textref + R_p (p_textref - p_m) tag2f \n v_textolc^textref = v_textref + k_q(q_textref - q_m) tag2g\nendalign","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"In this case, the measurement of power are being done in the capacitor of the LCL filter. However, depending on the model, this measurements could be different depending on where is the point of common coupling.","category":"page"},{"location":"component_models/outer_control/#Active-and-Reactive-Virtual-Oscillator-Controllers-[OuterControl]","page":"Outer Control","title":"Active and Reactive Virtual Oscillator Controllers [OuterControl]","text":"","category":"section"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"The following model represents a Virtual Oscillator Controller for both active and reactive power to generate the voltage references that will be used in the Voltage Controller. The contructor is OuterControl{ActiveVirtualOscillator, ReactiveVirtualOscillator} It defines a new SRF denoted as theta_textolc and a voltage reference E_textolc. The equations are:","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"beginalign\n dottheta_textolc = Omega_b (omega_textolc - omega_textsys) tag3a \n dotE_olc = Omega_b left(frack_1E_oc (-sin(gamma) (p_textref - p_e) + cos(gamma)(q_textref - q_e)) + k_2 (V_textref - E_oc^2)E_oc right) tag3b \nendalign","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"with","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"beginalign\n gamma = psi - fracpi2 tag3c \n omega_textolc = omega_textsys + frack_1E_oc^2 left(cos(gamma) (p_textref - p_e) + sin(gamma)(q_textref - q_e) right) tag3d \n p_e = v_ri_r + v_ii_i tag3e \n q_e = v_ii_r - v_ri_i tag3f \nendalign","category":"page"},{"location":"component_models/outer_control/#Active-and-Reactive-Power-PI-Controllers-(Grid-Following)-[OuterControl]","page":"Outer Control","title":"Active and Reactive Power PI Controllers (Grid Following) [OuterControl]","text":"","category":"section"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"The following model represents a PI controller for both active and reactive power to generate the current references that will be used in the Current Controller of the inner control CurrentModeControl. The constructor is OuterControl{ActivePowerPI, ReactivePowerPI}. The equations are:","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"beginalign\n dotsigma_p = p_textref - p_m tag4a \n dotp_m = omega_z (p_e - p_m) tag4b \n dotsigma_q = q_textref - q_m tag4c \n dotq_m = omega_f (q_e - p_m) tag4d \nendalign","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"with","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"beginalign\n p_e = v_ri_r + v_ii_i tag4e \n q_e = v_ii_r - v_ri_i tag4f \n omega_textolc = omega_textpll tag4g \n theta_textolc = theta_textpll tag4h \n i_textdcv^textref = k_p^q (q_textref - q_m) + k_i^q sigma_q tag4i \n i_textqcv^textref = k_p^p (p_textref - p_m) + k_i^p sigma_p tag4j \nendalign","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"This models requires a PLL to have a SRF for an internal dq reference frame. Contrary to the Grid-Forming model, it cannot work without a PLL. Since this Outer Control outputs a current reference, it can only be used with a current mode inner control (i.e. that receives a current reference instead of a voltage reference).","category":"page"},{"location":"component_models/outer_control/#Active-and-Reactive-Generic-Renewable-Controller-Type-AB-[OuterControl]","page":"Outer Control","title":"Active and Reactive Generic Renewable Controller Type AB [OuterControl]","text":"","category":"section"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"The following model represents an outer controller for both active and reactive power from generic industrial models REPCA and REECB to generate the current references that will be used in the Current Controller of the inner control RECurrentControlB. The constructor is OuterControl{ActiveRenewableControllerAB, ReactiveRenewableControllerAB}. The equations will depend on the flags used.","category":"page"},{"location":"component_models/outer_control/#Active-part","page":"Outer Control","title":"Active part","text":"","category":"section"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"In the case of F_Flag = 1 the equations (without limits and freezing) are:","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"beginalign\n dotp_textflt = frac1T_p (p_e - p_textflt) tag5a \n dotxi_P = p_texterr tag5b \n dotp_textext = frac1T_g (K_pg p_texterr + K_ig xi_P) tag5c \n dotp_textord = frac1T_textpord (p_textext - p_textord) tag5d\nendalign","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"with","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"beginalign\n p_e = v_ri_r + v_ii_i tag5e \n p_texterr = p_textref + p_textdroop - p_textflt tag5f \nendalign","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"In the case of F_Flag = 0 the equations (without limits) are simply","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"beginalign\n dotp_textord = frac1T_textpord (p_textref - p_textord) tag5g\nendalign","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"The current command going to the Inner Loop is computed as:","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"beginalign\n I_textocpcmd = fracp_textordV_texttflt tag5h\nendalign","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"on which V_texttflt is the filtered terminal bus voltage coming from the inner controller.","category":"page"},{"location":"component_models/outer_control/#Reactive-part","page":"Outer Control","title":"Reactive part","text":"","category":"section"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"In the case of VC_Flag = 0, Ref_Flag = 0, PF_Flag = 0, V_Flag = 1 the equations (without limits and freezing) are:","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"beginalign\n dotq_textflt = frac1T_textfltr (q_e - q_textflt) tag5i \n dotxi_textqoc = q_texterr tag5j \n dotq_LL = frac1T_fv(Q_textpi ( 1 - T_ftT_fv) - q_LL) tag5k \n dotxi_Q = V_textpiin tag5l \nendalign","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"with","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"beginalign\n q_e = v_ii_r - v_ri_i tag5m \n q_texterr = q_textref - q_flt tag5n \n Q_textpi = K_p q_texterr + K_i xi_textqoc tag5o \n Q_textext = q_LL + fracT_ftT_fv Q_textpi tag5p \n V_textpiin = Q_textext - q_e tag5q \nendalign","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"The output to the inner controller are V_textocqcmd if the Q_Flag = 1 on the Inner Controller, or I_textocqcmd if Q_Flag = 0:","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"beginalign\n V_textocqcmd = (K_qp V_textpiin + K_qi xi_Q) - V_texttflt tag5r \n I_textocqmcd = fracQ_textextmax(V_texttflt 001) tag5s\nendalign","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"In the case of VC_Flag = 0, Ref_Flag = 0, PF_Flag = 0, V_Flag = 1 the equations (without limits and freezing) are:","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"beginalign\n dotq_textflt = frac1T_textfltr (q_e - q_textflt) tag5t \n dotxi_textqoc = q_texterr tag5u \n dotq_LL = frac1T_fv(Q_textpi ( 1 - T_ftT_fv) - q_LL) tag5v \nendalign","category":"page"},{"location":"component_models/outer_control/","page":"Outer Control","title":"Outer Control","text":"The remaining models for other flags will be included when implemented in PowerSimulationsDynamics.jl.","category":"page"},{"location":"perturbations/#Perturbations","page":"Perturbations","title":"Perturbations","text":"","category":"section"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"Perturbations are used to alter the system from its steady state operation. If a Simulation is properly initialized, all states will remain fixed in their initial condition if no perturbation is applied to the system.","category":"page"},{"location":"perturbations/#List-of-perturbations","page":"Perturbations","title":"List of perturbations","text":"","category":"section"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"NetworkSwitch: allows to modify directly the admittance matrix, Ybus, used in the Simulation.\nBranchTrip: completely disconnects a branch from the system.\nBranchImpedanceChange: change the impedance of a branch by a user defined multiplier. \nGeneratorTrip: allows to disconnect a Dynamic Generation unit from the system.\nControlReferenceChange: allows to change the reference setpoint provided by a generator/inverter.\nLoadChange: allows to change the active or reactive power setpoint from a load.\nLoadTrip: allows the user to disconnect a load from the system.\nSourceBusVoltageChange: allows to change the reference setpoint provided by a voltage source.","category":"page"},{"location":"perturbations/#Examples","page":"Perturbations","title":"Examples","text":"","category":"section"},{"location":"perturbations/#Example-1:-Circuit-Disconnection-using-NetworkSwitch","page":"Perturbations","title":"Example 1: Circuit Disconnection using NetworkSwitch","text":"","category":"section"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"Consider a two bus system connected via a double circuit line, on which each circuit has parameters, r = 0.0, x = 0.1, b = 0.0 per unit, then the admittance matrix of the original system is given by:","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"yb = [0.0 - 20.0im 0.0 + 20.0im\n 0.0 + 20.0im 0.0 - 20.0im]","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"Triping one circuit can be modeled by doubling the impedance, i.e., dividing by 2 the admittance:","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"new_yb = [0.0 - 10.0im 0.0 + 10.0im\n 0.0 + 10.0im 0.0 - 10.0im]","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"To apply a Network Switch, we require to use a sparse matrix, so we can do this by simply:","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"using SparseArrays\nnew_yb = sparse(new_yb)","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"Then, this perturbation ocurring at t = 10 seconds can be included as:","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"ns1 = NetworkSwitch(1.0, new_yb)","category":"page"},{"location":"perturbations/#Example-2:-Three-Phase-Fault-using-NetworkSwitch","page":"Perturbations","title":"Example 2: Three Phase Fault using NetworkSwitch","text":"","category":"section"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"Another perturbation that can be modeled is a three phase fault at Bus 1 with impedance r_f = 0.0001, x_f = 0.0 per unit, then the admittance of this new system is:","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"new_yb2 = [10000.0 - 20.0im 0.0 + 20.0im\n 0.0 + 20.0im 0.0 - 20.0im]","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"Then, this perturbation ocurring at t = 10 seconds can be included as:","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"new_yb2 = sparse(new_yb2)\nns2 = NetworkSwitch(1.0, new_yb2)","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"Now, consider that the fault is cleared at t = 105 seconds by disconnecting the Circuit 2 of the line. This can be modeled with the single circuit admittance matrix:","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"new_yb3 = [0.0 - 10.0im 0.0 + 10.0im\n 0.0 + 10.0im 0.0 - 10.0im]","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"and the perturbation as:","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"new_yb3 = sparse(new_yb3)\nns3 = NetworkSwitch(1.05, new_yb3)","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"Then, the entire perturbation for the Simulation can be included in a vector of perturbations as:","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"three_fault = [ns2, ns3]","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"that can be passed as a perturbation argument in the Simulation construction.","category":"page"},{"location":"perturbations/#Example-3:-BranchTrip","page":"Perturbations","title":"Example 3: BranchTrip","text":"","category":"section"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"Consider the following 2 bus system defined by:","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"buses = [\n Bus(1, \"nodeA\", \"REF\", 0, 1.0, (min = 0.9, max = 1.05), 230, nothing, nothing),\n Bus(2, \"nodeB\", \"PV\", 0, 1.0, (min = 0.9, max = 1.05), 230, nothing, nothing),\n]\n\nline1 = Line(\n \"Circuit1\",\n true,\n 0.0,\n 0.0,\n Arc(from = buses[1], to = buses[2]),\n 0.00,\n 0.1,\n (from = 0.0, to = 0.0),\n 2.0,\n (min = -0.7, max = 0.7),\n )\nline2 = Line(\n \"Circuit2\",\n true,\n 0.0,\n 0.0,\n Arc(from = buses[1], to = buses[2]),\n 0.0,\n 0.1,\n (from = 0.0, to = 0.0),\n 2.0,\n (min = -0.7, max = 0.7),\n )\n\nsys = System(100.0, buses, [], [], [line1, line2])","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"A Branch Trip of Circuit 2 at time t = 10 seconds, can be implemented as:","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"b_trip = BranchTrip(1.0, Line, \"Circuit2\")","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"Note: Islanding is currently not supported in PowerSimulationsDynamics.jl. If a BranchTrip isolates a generation unit, the system may diverge due to the isolated generator.","category":"page"},{"location":"perturbations/#Example-4:-BranchImpedanceChange","page":"Perturbations","title":"Example 4: BranchImpedanceChange","text":"","category":"section"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"Following the same example as before, it is possible to amplify the impedance of a single circuit by 2.0 (that would represent that this Circuit is actually composed by 2 circuits) using the following perturbation:","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"b_change = BranchImpedanceChange(1.0, Line, \"Circuit2\", 2.0)","category":"page"},{"location":"perturbations/#Example-5:-GeneratorTrip","page":"Perturbations","title":"Example 5: GeneratorTrip","text":"","category":"section"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"Consider that you have a generator at bus 102, named \"generator-102-1\" in your system called sys. The constructor to trip it from the system is:","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"g = get_component(DynamicGenerator, sys, \"generator-102-1\")\ng_trip = GeneratorTrip(1.0, g)","category":"page"},{"location":"perturbations/#Example-6:-ControlReferenceChange","page":"Perturbations","title":"Example 6: ControlReferenceChange","text":"","category":"section"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"Consider that you have a generator at bus 102, named \"generator-102-1\" in your system called sys. The constructor to change is active power reference to 0.5 is:","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"g = get_component(DynamicGenerator, sys, \"generator-102-1\")\ncrc = ControlReferenceChange(1.0, g, :P_ref, 0.5)","category":"page"},{"location":"perturbations/#Example-7:-LoadChange","page":"Perturbations","title":"Example 7: LoadChange","text":"","category":"section"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"Consider that you have a load at bus 103, named \"load-103-1\" in your system called sys. The constructor to change is active power reference to 0.8 per unit at t = 10 seconds is:","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"l_device = get_component(ElectricLoad, sys, \"load-103-1\")\nl_change = LoadChange(1.0, l_device, :P_ref, 0.8)","category":"page"},{"location":"perturbations/#Example-8:-LoadTrip","page":"Perturbations","title":"Example 8: LoadTrip","text":"","category":"section"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"Consider that you have a load at bus 103, named \"load-103-1\" in your system called sys. The constructor to disconnect such load at t = 10 seconds is:","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"l_device = get_component(ElectricLoad, sys, \"load-103-1\")\nl_trip = LoadTrip(1.0, l_device)","category":"page"},{"location":"perturbations/#Example-9:-SourceBusVoltageChange","page":"Perturbations","title":"Example 9: SourceBusVoltageChange","text":"","category":"section"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"Consider that you have a voltage source at bus 101, named \"source-101-1\" in your system called sys. The constructor to change is voltage magnitude reference to 1.02 per unit at t = 10 seconds is:","category":"page"},{"location":"perturbations/","page":"Perturbations","title":"Perturbations","text":"s_device = get_component(Source, sys, \"source-101-1\")\ns_change = SourceBusVoltageChange(1.0, s_device, 1, 1.02)","category":"page"},{"location":"component_models/machines/#Machines","page":"Machine","title":"Machines","text":"","category":"section"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"The machine component describes the stator-rotor electromagnetic dynamics.","category":"page"},{"location":"component_models/machines/#Classical-Model-(Zero-Order)-[BaseMachine]","page":"Machine","title":"Classical Model (Zero Order) [BaseMachine]","text":"","category":"section"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"This is the classical order model that does not have differential equations in its machine model (delta and omega are defined in the shaft):","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"beginalign\n left beginarrayc i_d i_q endarray right = left beginarraycc r_a -x_d x_d r_a endarray right^-1 left beginarrayc -v_d e_q - v_q endarray right tag1a\np_e approx tau_e = (v_q + r_a i_q)i_q + (v_d + r_ai_d)i_d tag1b\nendalign","category":"page"},{"location":"component_models/machines/#One-d-One-q-Model-(2nd-Order)-[OneDOneQMachine]","page":"Machine","title":"One d- One q- Model (2nd Order) [OneDOneQMachine]","text":"","category":"section"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"This model includes two transient emf with their respective differential equations:","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"beginalign\ndote_q = frac1T_d0 left-e_q + (x_d-x_d)i_d + v_fright tag2a\ndote_d = frac1T_q0 left-e_d + (x_q-x_q)i_q right tag2b\n left beginarrayc i_d i_q endarray right = left beginarraycc r_a -x_q x_d r_a endarray right^-1 left beginarrayc e_d-v_d e_q - v_q endarray right tag2c\np_e approx tau_e = (v_q + r_a i_q)i_q + (v_d + r_ai_d)i_d tag2d\nendalign","category":"page"},{"location":"component_models/machines/#Marconato-Machine-(6th-Order)-[MarconatoMachine]","page":"Machine","title":"Marconato Machine (6th Order) [MarconatoMachine]","text":"","category":"section"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"The Marconato model defines 6 differential equations, two for stator fluxes and 4 for transient and subtransient emfs:","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"beginalign\ndotpsi_d = Omega_b(r_ai_d + omega psi_q + v_d) tag3a \ndotpsi_q = Omega_b(r_ai_q - omega psi_d + v_q) tag3b \ndote_q = frac1T_d0 left-e_q - (x_d-x_d-gamma_d)i_d + left(1- fracT_AAT_d0 right) v_fright tag3c\ndote_d = frac1T_q0 left-e_d + (x_q-x_q-gamma_q)i_q right tag3d\ndote_q = frac1T_d0 left-e_q + e_q - (x_d-x_d+gamma_d)i_d + fracT_AAT_d0v_f right tag3e \ndote_d = frac1T_q0 left-e_d + e_d + (x_q-x_q+gamma_q)i_q right tag3f \ni_d = frac1x_d (e_q - psi_d) tag3g \ni_q = frac1x_q (-e_d - psi_q) tag3h \ntau_e = psi_d i_q - psi_q i_d tag3i\nendalign","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"with","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"beginalign*\n gamma_d = fracT_d0 x_dT_d0 x_d (x_d - x_d) \n gamma_q = fracT_q0 x_qT_q0 x_q (x_q - x_q)\nendalign*","category":"page"},{"location":"component_models/machines/#Simplified-Marconato-Machine-(4th-Order)-[SimpleMarconatoMachine]","page":"Machine","title":"Simplified Marconato Machine (4th Order) [SimpleMarconatoMachine]","text":"","category":"section"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"This model neglects the derivative of stator fluxes (dotpsi_d and dotpsi_q) and assume that the rotor speed stays close to 1 pu (omegapsi_d=psi_d and omegapsi_q=psi_q) that allows to remove the stator fluxes variables from the Marconato model.","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"beginalign\ndote_q = frac1T_d0 left-e_q - (x_d-x_d-gamma_d)i_d + left(1- fracT_AAT_d0 right) v_fright tag4a\ndote_d = frac1T_q0 left-e_d + (x_q-x_q-gamma_q)i_q right tag4b\ndote_q = frac1T_d0 left-e_q + e_q - (x_d-x_d+gamma_d)i_d + fracT_AAT_d0v_f right tag4c \ndote_d = frac1T_q0 left-e_d + e_d + (x_q-x_q+gamma_q)i_q right tag4d \nleft beginarrayc i_d i_q endarray right = left beginarraycc r_a -x_q x_d r_a endarray right^-1 left beginarrayc e_d-v_d e_q - v_q endarray right tag4e\np_e approx tau_e = (v_q + r_a i_q)i_q + (v_d + r_ai_d)i_d tag4f\nendalign","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"with","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"beginalign*\n gamma_d = fracT_d0 x_dT_d0 x_d (x_d - x_d) \n gamma_q = fracT_q0 x_qT_q0 x_q (x_q - x_q)\nendalign*","category":"page"},{"location":"component_models/machines/#Anderson-Fouad-Machine-(6th-Order)-[AndersonFouadMachine]","page":"Machine","title":"Anderson-Fouad Machine (6th Order) [AndersonFouadMachine]","text":"","category":"section"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"The Anderson-Fouad model also defines 6 differential equations, two for stator fluxes and 4 for transient and subtransient emfs and is derived from the Marconato model by defining gamma_d approx gamma_q approx T_AA approx 0:","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"beginalign\ndotpsi_d = Omega_b(r_ai_d + omega psi_q + v_d) tag5a \ndotpsi_q = Omega_b(r_ai_q - omega psi_d + v_q) tag5b \ndote_q = frac1T_d0 left-e_q - (x_d-x_d)i_d + v_fright tag5c\ndote_d = frac1T_q0 left-e_d + (x_q-x_q)i_q right tag5d\ndote_q = frac1T_d0 left-e_q + e_q - (x_d-x_d)i_d right tag5e \ndote_d = frac1T_q0 left-e_d + e_d + (x_q-x_q)i_q right tag5f \ni_d = frac1x_d (e_q - psi_d) tag5g \ni_q = frac1x_q (-e_d - psi_q) tag5h \ntau_e = psi_d i_q - psi_q i_d tag5i\nendalign","category":"page"},{"location":"component_models/machines/#Simplified-Anderson-Fouad-Machine-(4th-Order)-[SimpleAFMachine]","page":"Machine","title":"Simplified Anderson-Fouad Machine (4th Order) [SimpleAFMachine]","text":"","category":"section"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"Similar to the Simplified Marconato Model, this model neglects the derivative of stator fluxes (dotpsi_d and dotpsi_q) and assume that the rotor speed stays close to 1 pu (omega psi_d = psi_d and omega psi_q = psi_q) that allows to remove the stator fluxes variables from the model:","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"beginalign\ndote_q = frac1T_d0 left-e_q - (x_d-x_d)i_d + v_fright tag6a\ndote_d = frac1T_q0 left-e_d + (x_q-x_q)i_q right tag6b\ndote_q = frac1T_d0 left-e_q + e_q - (x_d-x_d)i_d right tag6c \ndote_d = frac1T_q0 left-e_d + e_d + (x_q-x_q)i_q right tag6d \nleft beginarrayc i_d i_q endarray right = left beginarraycc r_a -x_q x_d r_a endarray right^-1 left beginarrayc e_d-v_d e_q - v_q endarray right tag6e\np_e approx tau_e = (v_q + r_a i_q)i_q + (v_d + r_ai_d)i_d tag6f\nendalign","category":"page"},{"location":"component_models/machines/#Round-Rotor-Machine-(4th-Order)-[RoundRotorQuadratic,-RoundRotorExponential]","page":"Machine","title":"Round Rotor Machine (4th Order) [RoundRotorQuadratic, RoundRotorExponential]","text":"","category":"section"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"This model represents the traditional round rotor models GENROU/GENROE models implemented in PSLF/PSSE/PowerWorld. Similar to the Simplified Marconato Model, this model neglects the derivative of stator fluxes (dotpsi_d and dotpsi_q). Round rotor machines must satisfy x_d = x_q.","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"beginalign\ndote_q = frac1T_d0 leftv_f - X_adI_fdright tag7a\ndote_d = frac1T_q0 left-X_aqI_1q right tag7b\ndotpsi_kd = frac1T_d0 left-psi_kd + e_q - (x_d-x_l)i_d right tag7c \ndotpsi_kq = frac1T_q0 left-psi_kq + e_d + (x_q-x_l)i_q right tag7d \nendalign","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"with:","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"beginalign\ngamma_d1 = fracx_d - x_lx_d - x_l tag7e\ngamma_q1 = fracx_q - x_lx_q - x_l tag7f\ngamma_d2 = fracx_d - x_d(x_d-x_l)^2 tag7g\ngamma_q2 = fracx_q - x_q(x_q - x_l)^2 tag7h\ngamma_qd = fracx_q - x_lx_d - x_l tag7i\npsi_q = gamma_q1 e_d + psi_kq (1 - gamma_q1) tag7j\npsi_d = gamma_d1 e_q + gamma_d2 (x_d - x_l) psi_kd tag7k\npsi = sqrt(psi_d)^2 + (psi_q)^2 tag7l\nleft beginarrayc i_d i_q endarray right = left beginarraycc -r_a x_q -x_d r_a endarray right^-1 left beginarrayc v_d - psi_q -v_q + psi_d endarray right tag7m\nX_adI_fd = e_q + (x_d - x_d) (gamma_d1 i_d - gamma_d2 psi_kd + gamma_d2 + e_q) + textSe(psi) psi_d tag7n\nX_aqI_1q = e_d + (x_q - x_q) (gamma_q2 e_d - gamma_q2psi_kq - gamma_q1 i_q) + textSe(psi) psi_q gamma_qd tag7o \ntau_e = i_d (r_a i_d + v_d) + i_q(r_a i_q + v_q) tag7p\nendalign","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"The difference between GENROU and GENROE occurs in which additive saturation function textSe(psi) is used. Input data is provided by the saturation values at psi = 10 and psi = 12 p.u. For the GENROU model, the function used is:","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"beginalign\ntextSe(psi) = fracB(psi - A)^2 psi tag7q\nendalign","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"and for the GENROE model the function used is:","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"beginalign\ntextSe(psi) = B(psi)^A tag7r\nendalign","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"The parameters A and B for each function are computed using the two points given (10 textSe(10)) and (12 textSe(12)).","category":"page"},{"location":"component_models/machines/#Salient-Pole-Machine-(3rd-Order)-[SalientPoleQuadratic,-SalientPoleExponential]","page":"Machine","title":"Salient Pole Machine (3rd Order) [SalientPoleQuadratic, SalientPoleExponential]","text":"","category":"section"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"This model represents the traditional round rotor models GENSAL/GENSAE models implemented in PSLF/PSSE/PowerWorld. Similar to the GENROU Model, this model neglects the derivative of stator fluxes (dotpsi_d and dotpsi_q).","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"beginalign\ndote_q = frac1T_d0 leftv_f - X_adI_fdright tag8a\ndotpsi_kd = frac1T_d0 left-psi_kd + e_q - (x_d-x_l)i_d right tag8b \ndotpsi_q = frac1T_q0 left-psi_q - (x_q-x_q)i_q right tag8c \nendalign","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"with:","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"beginalign\ngamma_d1 = fracx_d - x_lx_d - x_l tag8d\ngamma_q1 = fracx_q - x_lx_q - x_l tag8e\ngamma_d2 = fracx_d - x_d(x_d-x_l)^2 tag8f\npsi_d = gamma_d1 e_q + gamma_q1 psi_kd tag8g\nleft beginarrayc i_d i_q endarray right = left beginarraycc -r_a x_q -x_d r_a endarray right^-1 left beginarrayc v_d - psi_q -v_q + psi_d endarray right tag8h\nX_adI_fd = e_q + textSe(e_q) e_q + (x_d - x_d) (i_d + gamma_d2 (e_q - psi_kd - (x_d - x_l)i_d) tag8i\ntau_e = i_d (r_a i_d + v_d) + i_q(r_a i_q + v_q) tag8j\nendalign","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"The difference between GENSAL and GENSAE occurs in which additive saturation function textSe(e_q) is used. Input data is provided by the saturation values at e_q = 10 and e_q = 12 p.u. For the GENSAL model, the function used is:","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"beginalign\ntextSe(e_q) = fracB(e_q - A)^2 e_q tag8k\nendalign","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"and for the GENSAE model the function used is:","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"beginalign\ntextSe(e_q) = B(e_q)^A tag8l\nendalign","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"The parameters A and B for each function are computed using the two points given (10 textSe(10)) and (12 textSe(12)).","category":"page"},{"location":"component_models/machines/#SauerPai-Machine-(6th-Order)-[SauerPaiMachine]","page":"Machine","title":"SauerPai Machine (6th Order) [SauerPaiMachine]","text":"","category":"section"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"The Sauer Pai model defines 6 differential equations as follows:","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"beginalign\ndotpsi_d = Omega_b(r_ai_d + omega psi_q + v_d) tag9a \ndotpsi_q = Omega_b(r_ai_q - omega psi_d + v_q) tag9b \ndote_q = frac1T_d0 left(-e_q - (x_d - x_d)(i_d + gamma_d2 * dotpsi_d) + v_f) tag9c\ndote_q = frac1T_q0 left(-e_d + (x_q - x_q)(i_q + gamma_q2 * dotpsi_q)) tag9d\ndotpsi_d = frac1T_d0 left(-psi_d + e_q - (x_d - x_l)*i_d) tag9e \ndotpsi_q = frac1T_q0 left(-psi_q - e_d - (x_q - x_l)*i_q) tag9f \ni_d = frac1x_d (gamma_d1 * e_q - psi_d + (1 - gamma_d1) * psi_d) tag9g \ni_q = frac1x_q ((-gamma_q1 * e_d - psi_q + (1 - gamma_q1) * psi_q) tag9h \ntau_e = psi_d i_q - psi_q i_d tag9i\nendalign","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"with","category":"page"},{"location":"component_models/machines/","page":"Machine","title":"Machine","text":"beginalign*\n gamma_d1 = fracx_d - x_lx_d - x_l \n gamma_q1 = fracx_q - x_lx_q - x_l \n gamma_d2 = frac1 - gamma_d1x_d - x_l \n gamma_q2 = frac1 - gamma_q1x_q - x_l\nendalign*","category":"page"},{"location":"component_models/shafts/#Shafts","page":"Shaft","title":"Shafts","text":"","category":"section"},{"location":"component_models/shafts/","page":"Shaft","title":"Shaft","text":"The shaft component defines the rotating mass of the synchronous generator.","category":"page"},{"location":"component_models/shafts/#Rotor-Mass-Shaft-[SingleMass]","page":"Shaft","title":"Rotor Mass Shaft [SingleMass]","text":"","category":"section"},{"location":"component_models/shafts/","page":"Shaft","title":"Shaft","text":"This is the standard model, on which one single mass (typically the rotor) is used to model the entire inertia of the synchronous generator. Each generator's rotating frame use a reference frequency omega_s, that typically is the synchronous one (i.e. omega_s = 10). The model defines two differential equations for the rotor angle delta and the rotor speed omega:","category":"page"},{"location":"component_models/shafts/","page":"Shaft","title":"Shaft","text":"beginalign\ndotdelta = Omega_b(omega - omega_s) tag1a \ndotomega = frac12H(tau_m - tau_e - D(omega-omega_s)) tag1b\nendalign","category":"page"},{"location":"component_models/shafts/#Five-Mass-Shaft-[FiveMassShaft]","page":"Shaft","title":"Five-Mass Shaft [FiveMassShaft]","text":"","category":"section"},{"location":"component_models/shafts/","page":"Shaft","title":"Shaft","text":"This model describes model connecting a high-pressure (hp) steam turbine, intermediate-pressure (ip) steam turbine, low-pressure (lp) steam pressure, rotor and exciter (ex) connected in series (in that order) in the same shaft using a spring-mass model:","category":"page"},{"location":"component_models/shafts/","page":"Shaft","title":"Shaft","text":"beginalign\ndotdelta = Omega_b(omega - omega_s) tag2a \ndotomega = frac12H left- tau_e - D(omega-omega_s)) - D_34 (omega-omega_lp) - D_45(omega-omega_ex) + K_lp(delta_lp-delta) +K_ex(delta_ex-delta) right tag2b \ndotdelta_hp = Omega_b(omega_hp - omega_s) tag2c \ndotomega_hp = frac12H_hp left tau_m - D_hp(omega_hp-omega_s) - D_12(omega_hp - omega_ip) + K_hp(delta_ip - delta_hp) right tag2d \ndotdelta_ip = Omega_b(omega_ip - omega_s) tag2e \ndotomega_ip = frac12H_ip left- D_ip(omega_ip-omega_s) - D_12(omega_ip - omega_hp) -D_23(omega_ip - omega_lp ) + K_hp(delta_hp - delta_ip) + K_ip(delta_lp-delta_ip) right tag2f \ndotdelta_lp = Omega_b(omega_lp-omega_s) tag2g \ndotomega_lp = frac12H_lp left - D_lp(omega_lp-omega_s) - D_23(omega_lp - omega_ip) -D_34(omega_lp - omega ) + K_ip(delta_ip - delta_lp) + K_lp(delta-delta_lp) right tag2h \ndotdelta_ex = Omega_b(omega_ex-omega_s) tag2i \ndotomega_ex = frac12H_ex left - D_ex(omega_ex-omega_s) - D_45(omega_ex - omega) + K_ex(delta - delta_ex) right tag2j\nendalign","category":"page"},{"location":"api/public/#PowerSimulationsDynamics","page":"Public API Reference","title":"PowerSimulationsDynamics","text":"","category":"section"},{"location":"api/public/","page":"Public API Reference","title":"Public API Reference","text":"CurrentModule = PowerSimulationsDynamics\nDocTestSetup = quote\n using PowerSimulationsDynamics\nend","category":"page"},{"location":"api/public/","page":"Public API Reference","title":"Public API Reference","text":"Modules = [PowerSimulationsDynamics]\nPublic = true\nPrivate = false","category":"page"},{"location":"api/public/#PowerSimulationsDynamics.BranchImpedanceChange","page":"Public API Reference","title":"PowerSimulationsDynamics.BranchImpedanceChange","text":"mutable struct BranchImpedanceChange <: Perturbation\n time::Float64\n branch_type::Type{<:PSY.ACBranch}\n branch_name::String\n multiplier::Float64\nend\n\nA BranchImpedanceChange change the impedance of a branch by a user defined multiplier. Currently there is only support for static branches disconnection, PowerSystems.Line and PowerSystems.Transformer2W. Future releases will provide support for a Dynamic Line disconnection.\n\nArguments:\n\ntime::Float64 : Defines when the Branch Impedance Change will happen. This time should be inside the time span considered in the Simulation\nbranch_tipe::Type{<:PowerSystems.ACBranch} : Type of branch modified\nbranch_name::String : User defined name for identifying the branch\nmultiplier::Float64 : User defined value for impedance multiplier.\n\n\n\n\n\n","category":"type"},{"location":"api/public/#PowerSimulationsDynamics.BranchTrip","page":"Public API Reference","title":"PowerSimulationsDynamics.BranchTrip","text":"mutable struct BranchTrip <: Perturbation\n time::Float64\n branch_type::Type{<:PowerSystems.ACBranch}\n branch_name::String\nend\n\nA BranchTrip completely disconnects a branch from the system. Currently there is only support for static branches disconnection, PowerSystems.Line and PowerSystems.Transformer2W. Future releases will provide support for a Dynamic Line disconnection. Note: Islanding is currently not supported in PowerSimulationsDynamics.jl. If a BranchTrip isolates a generation unit, the system may diverge due to the isolated generator.\n\nArguments:\n\ntime::Float64 : Defines when the Branch Trip will happen. This time should be inside the time span considered in the Simulation\nbranch_tipe::Type{<:PowerSystems.ACBranch} : Type of branch disconnected\nbranch_name::String : User defined name for identifying the branch\n\n\n\n\n\n","category":"type"},{"location":"api/public/#PowerSimulationsDynamics.ControlReferenceChange","page":"Public API Reference","title":"PowerSimulationsDynamics.ControlReferenceChange","text":"mutable struct ControlReferenceChange <: Perturbation\n time::Float64\n device::PowerSystems.DynamicInjection\n signal::Symbol\n ref_value::Float64\nend\n\nA ControlReferenceChange allows to change the reference setpoint provided by a generator/inverter.\n\nArguments:\n\ntime::Float64 : Defines when the Control Reference Change will happen. This time should be inside the time span considered in the Simulation\ndevice::Type{<:PowerSystems.DynamicInjection} : Dynamic device modified\nsignal::Symbol : determines which reference setpoint will be modified. The accepted signals are:\n:P_ref: Modifies the active power reference setpoint.\n:V_ref: Modifies the voltage magnitude reference setpoint (if used).\n:Q_ref: Modifies the reactive power reference setpoint (if used).\n:ω_ref: Modifies the frequency setpoint.\nref_value::Float64 : User defined value for setpoint reference.\n\n\n\n\n\n","category":"type"},{"location":"api/public/#PowerSimulationsDynamics.GeneratorTrip","page":"Public API Reference","title":"PowerSimulationsDynamics.GeneratorTrip","text":"mutable struct GeneratorTrip <: Perturbation\n time::Float64\n device::PowerSystems.DynamicInjection\nend\n\nA GeneratorTrip allows to disconnect a Dynamic Generation unit from the system at a specified time.\n\nArguments:\n\ntime::Float64 : Defines when the Generator Trip will happen. This time should be inside the time span considered in the Simulation\ndevice::Type{<:PowerSystems.DynamicInjection} : Device to be disconnected\n\n\n\n\n\n","category":"type"},{"location":"api/public/#PowerSimulationsDynamics.LoadChange","page":"Public API Reference","title":"PowerSimulationsDynamics.LoadChange","text":"mutable struct LoadChange <: Perturbation\n time::Float64\n device::PowerSystems.ElectricLoad\n signal::Symbol\n ref_value::Float64\nend\n\nA LoadChange allows to change the active or reactive power setpoint from a load.\n\nArguments:\n\ntime::Float64 : Defines when the Load Change will happen. This time should be inside the time span considered in the Simulation\ndevice::Type{<:PowerSystems.ElectricLoad} : Dynamic device modified\nsignal::Symbol : determines which reference setpoint will be modified. The accepted signals are:\n:P_ref: Modifies the active power reference setpoint.\n:Q_ref: Modifies the reactive power reference setpoint.\nref_value::Float64 : User defined value for setpoint reference.\n\n\n\n\n\n","category":"type"},{"location":"api/public/#PowerSimulationsDynamics.LoadTrip","page":"Public API Reference","title":"PowerSimulationsDynamics.LoadTrip","text":"mutable struct LoadTrip <: Perturbation\n time::Float64\n device::PowerSystems.ElectricLoad\nend\n\nA LoadTrip allows the user to disconnect a load from the system.\n\nArguments:\n\ntime::Float64 : Defines when the Generator Trip will happen. This time should be inside the time span considered in the Simulation\ndevice::Type{<:PowerSystems.ElectricLoad} : Device to be disconnected\n\n\n\n\n\n","category":"type"},{"location":"api/public/#PowerSimulationsDynamics.MassMatrixModel-Union{Tuple{Ctype}, Tuple{Any, Vector{Float64}, Type{Ctype}}} where Ctype<:PowerSimulationsDynamics.SimCache","page":"Public API Reference","title":"PowerSimulationsDynamics.MassMatrixModel","text":"Instantiate a MassMatrixModel for ODE inputs.\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.NetworkSwitch","page":"Public API Reference","title":"PowerSimulationsDynamics.NetworkSwitch","text":"function NetworkSwitch(\n time::Float64,\n ybus::SparseArrays.SparseMatrixCSC{Complex{Float64}, Int},\n)\n\nAllows to modify directly the admittance matrix, Ybus, used in the Simulation. This allows the user to perform branch modifications, three phase faults (with impedance larger than zero) or branch trips, as long as the new Ybus provided captures that perturbation.\n\nArguments:\n\ntime::Float64 : Defines when the Network Switch will happen. This time should be inside the time span considered in the Simulation\nybus::SparseArrays.SparseMatrixCSC{Complex{Float64}, Int} : Complex admittance matrix\n\n\n\n\n\n","category":"type"},{"location":"api/public/#PowerSimulationsDynamics.PerturbState","page":"Public API Reference","title":"PowerSimulationsDynamics.PerturbState","text":"function PerturbState(\n time::Float64,\n index::Int,\n value::Float64,\n)\n\nAllows the user to modify the state index by adding value. The user should modify dynamic states only, since algebraic state may require to do a reinitialization.\n\nArguments:\n\ntime::Float64 : Defines when the modification of the state will happen. This time should be inside the time span considered in the Simulation.\nindex::Int : Defines which state index you want to modify\nvalue::Float64 : Defines how much the state will increase in value\n\n\n\n\n\n","category":"type"},{"location":"api/public/#PowerSimulationsDynamics.ResidualModel-Union{Tuple{Ctype}, Tuple{Any, Vector{Float64}, Type{Ctype}}} where Ctype<:PowerSimulationsDynamics.SimCache","page":"Public API Reference","title":"PowerSimulationsDynamics.ResidualModel","text":"Instantiate an ResidualModel for ODE inputs.\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.ResidualModel-Union{Tuple{Ctype}, Tuple{T}, Tuple{PowerSimulationsDynamics.SimulationInputs, Vector{T}, Type{Ctype}}} where {T<:Float64, Ctype<:PowerSimulationsDynamics.JacobianCache}","page":"Public API Reference","title":"PowerSimulationsDynamics.ResidualModel","text":"Instantiate an ResidualModel for ForwardDiff calculations\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.Simulation-Union{Tuple{T}, Tuple{Type{T}, System, String, Tuple{Float64, Float64}}, Tuple{Type{T}, System, String, Tuple{Float64, Float64}, Vector{<:PowerSimulationsDynamics.Perturbation}}} where T<:PowerSimulationsDynamics.SimulationModel","page":"Public API Reference","title":"PowerSimulationsDynamics.Simulation","text":"function Simulation\n ::SimulationModel\n system::PowerSystems.System\n simulation_folder::String\n tspan::NTuple{2, Float64},\n perturbations::Vector{<:Perturbation} = Vector{Perturbation}();\n kwargs...,\nend\n\nBuilds the simulation object and conducts the indexing process. The original system is not modified and a copy its created and stored in the Simulation.\n\nArguments:\n\n::SimulationModel : Type of Simulation Model. ResidualModel or MassMatrixModel. See Models Section for more details\nsystem::PowerSystems.System : System data\nsimulation_folder::String : Folder directory\ntspan::NTuple{2, Float64} : Time span for simulation\nperturbations::Vector{<:Perturbation} : Vector of Perturbations for the Simulation. Default: No Perturbations\ninitialize_simulation::Bool : Runs the initialization routine. If false, simulation runs based on the operation point stored in System\ninitial_conditions::Vector{Float64} : Allows the user to pass a vector with the initial condition values desired in the simulation. If initialize_simulation = true, these values are used as a first guess and overwritten.\nfrequency_reference : Default ReferenceBus. Determines which frequency model is used for the network. Currently there are two options available:\nConstantFrequency assumes that the network frequency is 1.0 per unit at all times.\nReferenceBus will use the frequency state of a Dynamic Generator (rotor speed) or Dynamic Inverter (virtual speed) connected to the Reference Bus (defined in the Power Flow data) as the network frequency. If multiple devices are connected to such bus, the device with larger base power will be used as a reference. If a Voltage Source is connected to the Reference Bus, then a ConstantFrequency model will be used.\nsystem_to_file::Bool : Default false. Serializes the initialized system\nconsole_level::Logging : Default Logging.Warn. Sets the level of logging output to the console. Can be set to Logging.Error, Logging.Warn, Logging.Info or Logging.Debug\nfile_level::Logging : Default Logging.Info. Sets the level of logging output to file. Can be set to Logging.Error, Logging.Warn, Logging.Info or Logging.Debug\ndisable_timer_outputs::Bool : Default false. Allows the user to display timer information about the construction and initilization of the Simulation.\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.SourceBusVoltageChange","page":"Public API Reference","title":"PowerSimulationsDynamics.SourceBusVoltageChange","text":"mutable struct SourceBusVoltageChange <: Perturbation\n time::Float64\n device::PSY.Source\n signal::Symbol\n ref_value::Float64\nend\n\nA SourceBusVoltageChange allows to change the reference setpoint provided by a voltage source.\n\nArguments:\n\ntime::Float64 : Defines when the Control Reference Change will happen. This time should be inside the time span considered in the Simulation\ndevice::Type{<:PowerSystems.Source} : Device modified\nsignal::Symbol : determines which reference setpoint will be modified. The accepted signals are:\n:V_ref Modifies the internal voltage magnitude reference setpoint.\n:θ_ref Modifies the internal voltage angle reference setpoint.\nref_value::Float64 : User defined value for setpoint reference.\n\n\n\n\n\n","category":"type"},{"location":"api/public/#PowerSimulationsDynamics.Simulation!-Union{Tuple{T}, Tuple{Type{T}, System, String, Tuple{Float64, Float64}}, Tuple{Type{T}, System, String, Tuple{Float64, Float64}, Vector{<:PowerSimulationsDynamics.Perturbation}}} where T<:PowerSimulationsDynamics.SimulationModel","page":"Public API Reference","title":"PowerSimulationsDynamics.Simulation!","text":"function Simulation!\n ::SimulationModel\n system::PowerSystems.System\n simulation_folder::String\n tspan::NTuple{2, Float64},\n perturbations::Vector{<:Perturbation} = Vector{Perturbation}();\n kwargs...,\nend\n\nBuilds the simulation object and conducts the indexing process. The initial conditions are stored in the system.\n\nArguments:\n\n::SimulationModel : Type of Simulation Model. ResidualModel or MassMatrixModel. See Models Section for more details\nsystem::PowerSystems.System : System data\nsimulation_folder::String : Folder directory\ntspan::NTuple{2, Float64} : Time span for simulation\nperturbations::Vector{<:Perturbation} : Vector of Perturbations for the Simulation. Default: No Perturbations\ninitialize_simulation::Bool : Runs the initialization routine. If false, simulation runs based on the operation point stored in System\ninitial_conditions::Vector{Float64} : Allows the user to pass a vector with the initial condition values desired in the simulation. If initialize_simulation = true, these values are used as a first guess and overwritten.\nfrequency_reference : Default ReferenceBus. Determines which frequency model is used for the network. Currently there are two options available:\nConstantFrequency assumes that the network frequency is 1.0 per unit at all times.\nReferenceBus will use the frequency state of a Dynamic Generator (rotor speed) or Dynamic Inverter (virtual speed) connected to the Reference Bus (defined in the Power Flow data) as the network frequency. If multiple devices are connected to such bus, the device with larger base power will be used as a reference. If a Voltage Source is connected to the Reference Bus, then a ConstantFrequency model will be used.\nsystem_to_file::Bool : Default false. Serializes the initialized system\nconsole_level::Logging : Default Logging.Warn. Sets the level of logging output to the console. Can be set to Logging.Error, Logging.Warn, Logging.Info or Logging.Debug\nfile_level::Logging : Default Logging.Info. Sets the level of logging output to file. Can be set to Logging.Error, Logging.Warn, Logging.Info or Logging.Debug\ndisable_timer_outputs::Bool : Default false. Allows the user to display timer information about the construction and initilization of the Simulation.\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.execute!-Tuple{Simulation, Any}","page":"Public API Reference","title":"PowerSimulationsDynamics.execute!","text":"execute!(\n sim::Simulation,\n solver;\n kwargs...\n)\n\nSolves the time-domain dynamic simulation model.\n\nArguments\n\nsim::Simulation : Initialized simulation object\nsolver : Solver used for numerical integration. Must be passed correctly depending on the Type of Simulation Model\nenable_progress_bar::Bool : Default: true. Enables progress bar for the integration routine.\nAdditional solver keyword arguments can be included. See Common Solver Options in the DifferentialEquations.jl documentation for more details.\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.get_activepower_branch_flow-Tuple{SimulationResults, String, Symbol}","page":"Public API Reference","title":"PowerSimulationsDynamics.get_activepower_branch_flow","text":"get_activepower_branch_flow(\n res::SimulationResults,\n name::String,\n location::Symbol,\n)\n\nFunction to obtain the active power flowing through the series element of a Branch. The user must specified is the power should be computed in the :from or to :bus, by specifying a symbol.\n\nIf :from is specified, the power is computed flowing outwards the :from bus. If :to is specified, the power is computed flowing into the :to bus.\n\nArguments\n\nres::SimulationResults : Simulation Results object that contains the solution\nname::String : Name to identify the specified line\nlocation::Symbol : :from or :to to specify a bus\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.get_activepower_series-Tuple{SimulationResults, String}","page":"Public API Reference","title":"PowerSimulationsDynamics.get_activepower_series","text":"get_activepower_series(\n res::SimulationResults,\n name::String,\n)\n\nFunction to obtain the active power output time series of a Dynamic Injection series out of the DAE Solution.\n\nArguments\n\nres::SimulationResults : Simulation Results object that contains the solution\nname::String : Name to identify the specified device\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.get_field_current_series-Tuple{SimulationResults, String}","page":"Public API Reference","title":"PowerSimulationsDynamics.get_field_current_series","text":"get_field_current_series(\n res::SimulationResults,\n name::String,\n)\n\nFunction to obtain the field current time series of a Dynamic Generator out of the DAE Solution.\n\nArguments\n\nres::SimulationResults : Simulation Results object that contains the solution\nname::String : Name to identify the specified device\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.get_field_voltage_series-Tuple{SimulationResults, String}","page":"Public API Reference","title":"PowerSimulationsDynamics.get_field_voltage_series","text":"get_field_voltage_series(\n res::SimulationResults,\n name::String,\n)\n\nFunction to obtain the field voltage time series of a Dynamic Generator out of the DAE Solution.\n\nArguments\n\nres::SimulationResults : Simulation Results object that contains the solution\nname::String : Name to identify the specified device\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.get_frequency_series-Tuple{SimulationResults, String}","page":"Public API Reference","title":"PowerSimulationsDynamics.get_frequency_series","text":"get_frequency_series(\n res::SimulationResults,\n name::String,\n)\n\nFunction to obtain the frequency time series of a Dynamic Injection out of the DAE Solution.\n\nArguments\n\nres::SimulationResults : Simulation Results object that contains the solution\nname::String : Name to identify the specified device\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.get_imaginary_current_branch_flow-Tuple{SimulationResults, String}","page":"Public API Reference","title":"PowerSimulationsDynamics.get_imaginary_current_branch_flow","text":"get_imaginary_current_branch_flow(\n res::SimulationResults,\n name::String,\n)\n\nFunction to obtain the imaginary current flowing through the series element of a Branch\n\nArguments\n\nres::SimulationResults : Simulation Results object that contains the solution\nname::String : Name to identify the specified line\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.get_imaginary_current_series-Tuple{SimulationResults, String}","page":"Public API Reference","title":"PowerSimulationsDynamics.get_imaginary_current_series","text":"get_imaginary_current_series(\n res::SimulationResults,\n name::String,\n)\n\nFunction to obtain the imaginary current time series of a Dynamic Injection series out of the DAE Solution.\n\nArguments\n\nres::SimulationResults : Simulation Results object that contains the solution\nname::String : Name to identify the specified device\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.get_jacobian-Union{Tuple{T}, Tuple{Type{T}, System}, Tuple{Type{T}, System, Int64}} where T<:PowerSimulationsDynamics.SimulationModel","page":"Public API Reference","title":"PowerSimulationsDynamics.get_jacobian","text":"function get_jacobian(\n::Type{T},\nsystem::PSY.System,\nsparse_retrieve_loop::Int = 3,\n) where {T <: SimulationModel}\n\nReturns the jacobian function of the system model resulting from the system data.\n\nArguments:\n\n::SimulationModel : Type of Simulation Model. ResidualModel or MassMatrixModel. See Models Section for more details\nsystem::PowerSystems.System : System data\nsparse_retrieve_loop::Int : Number of loops for sparsity detection. If 0, builds the Jacobian with a DenseMatrix\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.get_mechanical_torque_series-Tuple{SimulationResults, String}","page":"Public API Reference","title":"PowerSimulationsDynamics.get_mechanical_torque_series","text":"get_mechanical_torque_series(\n res::SimulationResults,\n name::String,\n)\n\nFunction to obtain the mechanical torque time series of the mechanical torque out of the DAE Solution.\n\nArguments\n\nres::SimulationResults : Simulation Results object that contains the solution\nname::String : Name to identify the specified device\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.get_pss_output_series-Tuple{SimulationResults, String}","page":"Public API Reference","title":"PowerSimulationsDynamics.get_pss_output_series","text":"get_pss_output_series(\n res::SimulationResults,\n name::String,\n)\n\nFunction to obtain the pss output time series of a Dynamic Generator out of the DAE Solution.\n\nArguments\n\nres::SimulationResults : Simulation Results object that contains the solution\nname::String : Name to identify the specified device\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.get_reactivepower_branch_flow-Tuple{SimulationResults, String, Symbol}","page":"Public API Reference","title":"PowerSimulationsDynamics.get_reactivepower_branch_flow","text":"get_reactivepower_branch_flow(\n res::SimulationResults,\n name::String,\n location::Symbol,\n)\n\nFunction to obtain the reactive power flowing through the series element of a Branch. The user must specified is the power should be computed in the :from or to :bus, by specifying a symbol.\n\nIf :from is specified, the power is computed flowing outwards the :from bus. If :to is specified, the power is computed flowing into the :to bus.\n\nArguments\n\nres::SimulationResults : Simulation Results object that contains the solution\nname::String : Name to identify the specified line\nlocation::Symbol : :from or :to to specify a bus\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.get_reactivepower_series-Tuple{SimulationResults, String}","page":"Public API Reference","title":"PowerSimulationsDynamics.get_reactivepower_series","text":"get_reactivepower_series(\n res::SimulationResults,\n name::String,\n)\n\nFunction to obtain the reactive power output time series of a Dynamic Injection series out of the DAE Solution.\n\nArguments\n\nres::SimulationResults : Simulation Results object that contains the solution\nname::String : Name to identify the specified device\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.get_real_current_branch_flow-Tuple{SimulationResults, String}","page":"Public API Reference","title":"PowerSimulationsDynamics.get_real_current_branch_flow","text":"get_real_current_branch_flow(\n res::SimulationResults,\n name::String,\n)\n\nFunction to obtain the real current flowing through the series element of a Branch\n\nArguments\n\nres::SimulationResults : Simulation Results object that contains the solution\nname::String : Name to identify the specified line\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.get_real_current_series-Tuple{SimulationResults, String}","page":"Public API Reference","title":"PowerSimulationsDynamics.get_real_current_series","text":"get_real_current_series(\n res::SimulationResults,\n name::String,\n)\n\nFunction to obtain the real current time series of a Dynamic Injection series out of the DAE Solution.\n\nArguments\n\nres::SimulationResults : Simulation Results object that contains the solution\nname::String : Name to identify the specified device\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.get_setpoints-Tuple{Simulation}","page":"Public API Reference","title":"PowerSimulationsDynamics.get_setpoints","text":"get_setpoints(sim::Simulation)\n\nFunction that returns the reference setpoints for all the dynamic devices.\n\nArguments\n\nsim::Simulation : Simulation object that contains the initial condition and setpoints.\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.get_source_imaginary_current_series","page":"Public API Reference","title":"PowerSimulationsDynamics.get_source_imaginary_current_series","text":"Function to obtain output imaginary current for a source. It receives the simulation results, the Source name and an optional argument of the time step of the results.\n\n\n\n\n\n","category":"function"},{"location":"api/public/#PowerSimulationsDynamics.get_source_real_current_series","page":"Public API Reference","title":"PowerSimulationsDynamics.get_source_real_current_series","text":"Function to obtain output real current for a source. It receives the simulation results, the Source name and an optional argument of the time step of the results.\n\n\n\n\n\n","category":"function"},{"location":"api/public/#PowerSimulationsDynamics.get_state_series-Tuple{SimulationResults, Tuple{String, Symbol}}","page":"Public API Reference","title":"PowerSimulationsDynamics.get_state_series","text":"get_state_series(\n res::SimulationResults,\n ref::Tuple{String, Symbol};\n dt::Union{Nothing, Float64} = nothing\n)\nend\n\nFunction to obtain series of states out of DAE Solution.\n\nArguments\n\nres::SimulationResults : Simulation Results object that contains the solution\nref:Tuple{String, Symbol} : Tuple used to identify the dynamic device, via its name, as a String, and the associated state as a Symbol.\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.get_voltage_angle_series-Tuple{SimulationResults, Int64}","page":"Public API Reference","title":"PowerSimulationsDynamics.get_voltage_angle_series","text":"get_voltage_angle_series(\n res::SimulationResults,\n bus_number::Int\n)\n\nFunction to obtain the voltage angle series out of the DAE Solution.\n\nArguments\n\nres::SimulationResults : Simulation Results object that contains the solution\nbus_number::Int : Bus number identifier\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.get_voltage_magnitude_series-Tuple{SimulationResults, Int64}","page":"Public API Reference","title":"PowerSimulationsDynamics.get_voltage_magnitude_series","text":"get_voltage_magnitude_series(\n res::SimulationResults,\n bus_number::Int\n)\n\nFunction to obtain the voltage magnitude series out of the DAE Solution.\n\nArguments:\n\nres::SimulationResults : Simulation Results object that contains the solution\nbus_number::Int : Bus number identifier\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.read_initial_conditions-Tuple{Simulation}","page":"Public API Reference","title":"PowerSimulationsDynamics.read_initial_conditions","text":"Returns a Dictionary with the resulting initial conditions of the simulation\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.show_states_initial_value-Tuple{SimulationResults}","page":"Public API Reference","title":"PowerSimulationsDynamics.show_states_initial_value","text":"show_states_initial_value(res::SimulationResults)\n\nFunction to print initial states.\n\nArguments\n\nres::SimulationResults : Simulation Results object that contains the solution\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.show_states_initial_value-Tuple{Simulation}","page":"Public API Reference","title":"PowerSimulationsDynamics.show_states_initial_value","text":"show_states_initial_value(sim::Simulation)\n\nFunction to print initial states.\n\nArguments\n\nsim::Simulation : Simulation object that contains the initial condition\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.summary_eigenvalues-Tuple{PowerSimulationsDynamics.SmallSignalOutput}","page":"Public API Reference","title":"PowerSimulationsDynamics.summary_eigenvalues","text":"summary_eigenvalues(\n sm::SmallSignalOutput,\n)\n\nFunction to obtain a summary of the eigenvalues of the Jacobian at the operating point. It returns a DataFrame with the most associated state for each eigenvalue, its real and imaginary part, damping and frequency.\n\nArguments\n\nsm::SmallSignalOutput : Small Signal Output object that contains the eigenvalues and participation factors\n\n\n\n\n\n","category":"method"},{"location":"api/public/#PowerSimulationsDynamics.summary_participation_factors-Tuple{PowerSimulationsDynamics.SmallSignalOutput}","page":"Public API Reference","title":"PowerSimulationsDynamics.summary_participation_factors","text":"summary_participation_factors(\n sm::SmallSignalOutput,\n)\n\nFunction to obtain the participation factor of each state to each eigenvalue. It returns a DataFrame with the participation factors of each state to all eigenvalues.\n\nArguments\n\nsm::SmallSignalOutput : Small Signal Output object that contains the eigenvalues and participation factors\n\n\n\n\n\n","category":"method"},{"location":"component_models/network/#Network-model","page":"Network","title":"Network model","text":"","category":"section"},{"location":"component_models/network/","page":"Network","title":"Network","text":"Here we discuss the models used to describe the network in PowerSimulationsDynamics.jl. This is based on a standard current injection model as defined in Power System Modelling and Scripting. The numerical advantages of current injection models outweigh the complexities of implementing constant power loads for longer-term transient stability analysis. The network is defined in a synchronous reference frame (SRF), named the RI (real-imaginary) reference frame, rotating at the constant base frequency Omega_b.","category":"page"},{"location":"component_models/network/","page":"Network","title":"Network","text":"In simple terms, PowerSimulationsDynamics.jl internally tracks the current-injection balances at the nodal level from all the devices on the system. Based on the buses and branches information, the system constructor computes the admittance matrix boldsymbolY assuming nominal frequency and this is used for static branch modeling. The algebraic equations for the static portions of the network are as follows:","category":"page"},{"location":"component_models/network/","page":"Network","title":"Network","text":" beginalign\n 0 = boldsymboli(boldsymbolx boldsymbolv) - boldsymbolYboldsymbolv\n endalign","category":"page"},{"location":"component_models/network/","page":"Network","title":"Network","text":"where boldsymboli = i_r + ji_i is the vector of the sum of complex current injections from devices , boldsymbolx is the vector of states and boldsymbolv = v_r + jv_i is the vector of complex bus voltages. Equations (1) connect all the port variables, i.e., currents, defined for each injection device. Components that contribute to (1) by modifying the current boldsymboli are (i) static injection devices, (ii) dynamic injection devices, and (iii) dynamic network branches. Components that contribute to modify the admittance matrix boldsymbolY are static branches.","category":"page"},{"location":"component_models/network/#Static-Branches-(or-Algebraic-Branches)","page":"Network","title":"Static Branches (or Algebraic Branches)","text":"","category":"section"},{"location":"component_models/network/#Lines","page":"Network","title":"Lines","text":"","category":"section"},{"location":"component_models/network/","page":"Network","title":"Network","text":"Each line is defined using a pi model connecting two buses (nm), with a series resistance r and reactance x, and a shunt capacitance at both ends (c_n c_m). The values are already in system per unit. Then each branch contributes to the admittance matrix as follows:","category":"page"},{"location":"component_models/network/","page":"Network","title":"Network","text":"beginalign\nY_nn += frac1r+jx + jc_n \nY_nm += frac-1r+jx \nY_mm += frac1r+jx + jc_m \nY_mn += frac-1r+jx \nendalign","category":"page"},{"location":"component_models/network/#Two-Windings-Transformers","page":"Network","title":"Two-Windings Transformers","text":"","category":"section"},{"location":"component_models/network/","page":"Network","title":"Network","text":"Similarly to lines these are defined by a series reactance and impedance. The equations are equivalently of the lines without the shunt capacitance.","category":"page"},{"location":"component_models/network/#Dynamic-Branches","page":"Network","title":"Dynamic Branches","text":"","category":"section"},{"location":"component_models/network/","page":"Network","title":"Network","text":"Dynamic network branches contribute directly to (1) by modifying the vector of complex currents. Their parameters are also the series resistance r and reactance x, and a shunt capacitance at both ends (c_n c_m) for a line ell. In addition, they define 3 new additional differential equations per line (6 in total for real and imaginary part):","category":"page"},{"location":"component_models/network/","page":"Network","title":"Network","text":"beginalign\n fraclOmega_b fracdboldsymboli_elldt = (boldsymbolv_n - boldsymbolv_m) - (r+jl) boldsymboli_ell \n fracc_nOmega_b fracdboldsymbolv_ndt = boldsymboli_n^textcap - jc_nboldsymbolv_n \n fracc_mOmega_b fracdboldsymbolv_mdt = boldsymboli_m^textcap - jc_mboldsymbolv_m\nendalign","category":"page"},{"location":"component_models/network/","page":"Network","title":"Network","text":"Since all the values are in per unit, the reactance is equal to the inductance.","category":"page"},{"location":"component_models/network/","page":"Network","title":"Network","text":"A detail discussion about the effects of different line models in the modeling of inverters is presented in Grid Forming Inverter Small Signal Stability: Examining Role of Line and Voltage Dynamics","category":"page"},{"location":"component_models/pss/#Power-System-Stabilizers-(PSS)","page":"PSS","title":"Power System Stabilizers (PSS)","text":"","category":"section"},{"location":"component_models/pss/","page":"PSS","title":"PSS","text":"PSS are used to add an additional signal v_s to the input signal of the AVR: v_textref = v_textref^textavr + v_s.","category":"page"},{"location":"component_models/pss/#Fixed-PSS-[PSSFixed]","page":"PSS","title":"Fixed PSS [PSSFixed]","text":"","category":"section"},{"location":"component_models/pss/","page":"PSS","title":"PSS","text":"This is a simple model that set the stabilization signal to be equal to a desired constant value v_s = v_s^textfix. The absence of PSS can be modelled using this component with v_s^textfix = 0.","category":"page"},{"location":"component_models/pss/#Simple-PSS-[PSSSimple]","page":"PSS","title":"Simple PSS [PSSSimple]","text":"","category":"section"},{"location":"component_models/pss/","page":"PSS","title":"PSS","text":"This is the most basic PSS that can be implemented, on which the stabilization signal is a proportional controller over the frequency and electrical power:","category":"page"},{"location":"component_models/pss/","page":"PSS","title":"PSS","text":"beginalign\nv_s = K_omega(omega - omega_s) + K_p(omega tau_e - P_textref) tag1a\nendalign","category":"page"},{"location":"component_models/pss/#IEEE-Stabilizer-[IEEEST]","page":"PSS","title":"IEEE Stabilizer [IEEEST]","text":"","category":"section"},{"location":"component_models/pss/","page":"PSS","title":"PSS","text":"The 7th-order PSS model is:","category":"page"},{"location":"component_models/pss/","page":"PSS","title":"PSS","text":"beginalign\nA_4 dotx_1 = u - A_3 x_1 - x_2 tag2a \ndotx_2 = x_1 tag2b \nA_2dotx_3 = x_2 - A_1 x_3 - x_4 tag2c\ndotx_4 = x_3 tag2d\nT_2dotx_5 = left(1 - fracT_1T_2right) y_f - x_5 tag2e\nT_4dotx_6 = left(1 - fracT_3T_4right) y_LL1 - x_6 tag2f\nT_6dotx_7 = -left(fracK_s T_5T_6 y_LL2 + x_7 right) tag2g\nendalign","category":"page"},{"location":"component_models/pss/","page":"PSS","title":"PSS","text":"with","category":"page"},{"location":"component_models/pss/","page":"PSS","title":"PSS","text":"beginalign*\ny_f = fracT_4T_2 x_2 + left(T_3 - T_1 fracT_4T_2right) x_3 + left(1 - fracT_4T_2right)x_4 \ny_LL1 = x_5 + fracT_1T_2 y_f \ny_LL2 = x_6 + fracT_3T_4 y_LL1 \ny_out = x_7 + fracK_s T_5T_6 y_LL2 \nV_s = textclamp(y_out textLs_textmin textLs_textmax)\nendalign*","category":"page"},{"location":"component_models/pss/","page":"PSS","title":"PSS","text":"on which u is the input signal to the PSS, that depends on the flag. Currently, rotor speed, electric torque, mechanical torque and voltage magnitude are supported inputs.","category":"page"},{"location":"component_models/pss/#STAB1-PSS-[STAB1]","page":"PSS","title":"STAB1 PSS [STAB1]","text":"","category":"section"},{"location":"component_models/pss/","page":"PSS","title":"PSS","text":"The 3rd-order PSS model is:","category":"page"},{"location":"component_models/pss/","page":"PSS","title":"PSS","text":"beginalign\nT dotx_1 = K omega - x_1 tag3a \nT_3dotx_2 = left(1 - fracT_1T_3right) x_1 - x_2 tag3b \nT_4dotx_3 = left(1 - fracT_2T_4right) y_LL - x_2 tag3c \nendalign","category":"page"},{"location":"component_models/pss/","page":"PSS","title":"PSS","text":"with","category":"page"},{"location":"component_models/pss/","page":"PSS","title":"PSS","text":"beginalign*\ny_LL = x_2 + fracT_1T_3 x_1 \ny_out = x_3 + fracT_2T_4 y_LL \nV_s = textclamp(y_out -H_lim H_lim)\nendalign*","category":"page"},{"location":"initialization/#Initialization-Routine","page":"Initialization","title":"Initialization Routine","text":"","category":"section"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"Dynamic Simulations require a reasonable initial condition for the system model. In most analysis, power systems models are initialized at a stable equilibrium, which implies that:","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"beginalign\n0 = F(x u eta)\nendalign","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"Finding the solution of a large non-linear system is challenging and requires a reasonable initial guess. In classical power systems literature, the routine to find equilibrium points for the dynamic injection devices' components is well known and used in free and commercial software (see Power System Modelling and Scripting page 224). However, in the case of converter interface dynamic injection models, such routines are not documented.","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"Initializing the system also requires finding valid set-points for the devices in the system. For instance, finding the reference voltage in an AVR to match the voltage magnitude resulting from the power flow solution. PowerSimulationsDynamics.jl prioritizes mathching the dynamic components control references to match the power flow results.","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"Finally, the initialization must instantiate not only the values of the states but also the inner vars. PowerSimulationsDynamics.jl handles all this initializations by default.","category":"page"},{"location":"initialization/#Initialization-interface","page":"Initialization","title":"Initialization interface","text":"","category":"section"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"By default PowerSimulationsDynamics.jl initializes the system following the steps described below. it is possible to provide an initial guess for the initial conditions to speed up the initialization process.","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"Simulation(\n ResidualModel,\n sys,\n pwd(),\n (0.0, 20.0);\n initial_conditions = x0_init,\n )","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"It is also possible to initialize the simulation using a flat start (V_mag = 1.0, V_angle = 0.0 and x0 = zeros) using initialize_simulation = false. However, for medium or large system this is unlikely to result in a valid initial condition for the simulation.","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"Simulation(\n ResidualModel,\n sys,\n pwd(),\n (0.0, 20.0);\n initialize_simulation = false,\n )","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"If you want to avoid PowerSimulationsDynamics.jl from finding an stable equilibrium automatically and provide the initial condition manually you can use the following flag combination.","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"Simulation(\n ResidualModel,\n sys,\n pwd(),\n (0.0, 20.0);\n initialize_simulation = false,\n initial_conditions = x0_init,\n )","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"WARNING!: when the initialize_simulation is set to false, neither the device set points nor the inner vars are initialized. Use these keywords with care and make sure the values in the system components match the initial conditions provided.","category":"page"},{"location":"initialization/#System-wide-initialization-routine","page":"Initialization","title":"System-wide initialization routine","text":"","category":"section"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"The initialization routine starts from the solution of the power flow equations. For each dynamic injection device PowerSimulationsDynamics.jl finds the solution of the systems of non-linear equations for each dynamic component following the sequences described in the forthcoming sections.","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"Once each device is individually initialized, the system-wide initial guess is used to solve the system (1). In a first attempt at finding the solution, the tolerance is set to a stringent tolerance. If the non-linear solver is unable to get a solution, it might usually reflect small signal stability problems in the system. In a second attempt, the tolerances are relaxed. If the solver succeeds, the simulation continues, but the user is warned.","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"","category":"page"},{"location":"initialization/#Initialization-of-the-Synchronous-Machines","page":"Initialization","title":"Initialization of the Synchronous Machines","text":"","category":"section"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"The initialization of Synchronous Machines is standard in power systems and follows the scheme shown in the figure. Other internal variables are calculated recursively from the power flow solution for the node on which the dynamic device isconnected. (Adapted from Power System Modelling and Scripting Figure 9.2)","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"(Image: init_machine)","category":"page"},{"location":"initialization/#Initialization-of-the-Inverters","page":"Initialization","title":"Initialization of the Inverters","text":"","category":"section"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"Initializing the inverters follows the sequence shown in the figure and has been developed to be compatible with the implementation of custom dynamic components. Given that the process is less studied and standard than the one of the synchronous machine, this page contains more detailed documentation of the process.","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"(Image: init_machine)","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"The first component to be initialized is the filter. Given that the filter is an RLC circuit connected to the grid, its currents and voltages need to match the results of the power flow. The initialization of the filter provides the values for the P and Q used in the outer control and the V and I needed in the inner controls.\nBased on the bus voltage in the system's reference frame V_r and the bus angle theta the PLL's can be initialized to obtain the angle and frequency estimates needed by the outer control.\nThe Outer Control calculates the internal angle delta_olc required by the inner control to estimate the voltage and current phase difference.\nThe DC Source uses the power set-point consistent with the power outputs of the filter to initialize the V_dc set-points. This value is used in the inner control.\nThe inner control takes the phase angle delta_olc and the V_dc to estimate the modulation values of the PWM converter.","category":"page"},{"location":"initialization/","page":"Initialization","title":"Initialization","text":"Note: The initialization of an inverter through the proposed meta-model is actively under development and subject to change. This page will maintain the latest version of the sequence.","category":"page"},{"location":"tutorials_page/#SIIP-Examples","page":"SIIP-Examples","title":"SIIP-Examples","text":"","category":"section"},{"location":"tutorials_page/","page":"SIIP-Examples","title":"SIIP-Examples","text":"All the tutorials for the SIIP project are part of a separate repository SIIP-Examples. You can access the latest PowerSimulationsDynamics.jl tutorial notebooks in this link","category":"page"},{"location":"tutorials_page/","page":"SIIP-Examples","title":"SIIP-Examples","text":"Specific examples of common workflows and models:","category":"page"},{"location":"tutorials_page/","page":"SIIP-Examples","title":"SIIP-Examples","text":"Loading Dynamic Data\nSolving a One Machine against Infinite Bus model\nChanging line modeling assumptions\nUsing an Inverter in a Multi-Machine Model","category":"page"},{"location":"tutorials/tutorial_continuation_pf/#Tutorial-Small-Signal-Analysis-with-Continuation-Power-Flow","page":"Small-Signal Analysis","title":"Tutorial Small Signal Analysis with Continuation Power Flow","text":"","category":"section"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"Originally Contributed by: Rodrigo Henriquez-Auba","category":"page"},{"location":"tutorials/tutorial_continuation_pf/#Introduction","page":"Small-Signal Analysis","title":"Introduction","text":"","category":"section"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"This tutorial will introduce you to the functionality of PowerSimulationsDynamics and PowerFlows for running small signal analysis in a continuation power flow.","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"This tutorial presents a simulation of a two-bus system with a generator (represented with a GENROU + SEXS + TGOV1 model) at bus 1, and a load on bus 2. We will increase the load demand to observe the P-V curve and run a small-signal analysis to check if the system satisfies small-signal stability at different operating points.","category":"page"},{"location":"tutorials/tutorial_continuation_pf/#Dependencies","page":"Small-Signal Analysis","title":"Dependencies","text":"","category":"section"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"using PowerSimulationsDynamics\nPSID = PowerSimulationsDynamics\nusing PowerSystemCaseBuilder\nusing PowerSystems\nusing PowerFlows\nconst PSY = PowerSystems\nusing Plots\ngr()\n\n# Disable Logging to avoid excessive information\nusing Logging\nLogging.disable_logging(Logging.Info); \nLogging.disable_logging(Logging.Warn); ","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"note: Note\nPowerSystemCaseBuilder.jl is a helper library that makes it easier to reproduce examples in the documentation and tutorials. Normally you would pass your local files to create the system data instead of calling the function build_system. For more details visit PowerSystemCaseBuilder Documentation","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"PowerSystems (abbreviated with PSY) is used to properly define the data structure and establish an equilibrium point initial condition with a power flow routine using PowerFlows.","category":"page"},{"location":"tutorials/tutorial_continuation_pf/#Load-the-system","page":"Small-Signal Analysis","title":"Load the system","text":"","category":"section"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"We load the system using PowerSystemCaseBuilder.jl. This system only have a generator without dynamic data on which we can use PowerFlows to generate a P-V (or nose) curve.","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"sys_static = build_system(PSIDSystems, \"2 Bus Load Tutorial\")","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"Note that this system contains an Exponential Load, but the parameters are set up to zero, so it behaves a Constant Power Load:","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"first(get_components(PSY.ExponentialLoad, sys_static))","category":"page"},{"location":"tutorials/tutorial_continuation_pf/#Create-a-P-V-curve","page":"Small-Signal Analysis","title":"Create a P-V curve","text":"","category":"section"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"The next step is to run multiple power flows and store the voltage at the load and the active power. For this example we will set up the power factor to be unitary (i.e. no reactive power at the load). ","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"# Create a Power Range to change the power load active power\nP_range = 0.01:0.01:4.6;\n# Choose the power factor\nload_pf = 1.0;","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"Then create vectors to store the results","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"# PV Curve Results\nP_load_p = Vector{Float64}();\nV_load_p = Vector{Float64}();","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"Then, we run multiple power flows in a for loop by changing the active power of the load:","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"for p in P_range\n # Change the active power and reactive power of the load\n power = p * 1.0\n load = get_component(PSY.ExponentialLoad, sys_static, \"load1021\")\n set_active_power!(load, power)\n q_power = power * tan(acos(load_pf))\n set_reactive_power!(load, q_power)\n # Run Power Flow\n status = solve_ac_powerflow!(sys_static)\n if !status\n # Finish the loop if the power flow fails\n print(\"Power Flow failed at p = $(power)\")\n break\n end\n # Obtain the bus voltage information\n bus = get_component(Bus, sys_static, \"BUS 2\")\n Vm = get_magnitude(bus)\n # Store values in the vectors\n push!(V_load_p, Vm)\n push!(P_load_p, power)\nend","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"The plot can be visualized with:","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"plot(P_load_p,\n V_load_p,\n label = \"PV Curve\",\n xlabel = \"Load Power [pu]\",\n ylabel = \"Load Bus Voltage [pu]\",\n color = :black\n)","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"(Image: plot)","category":"page"},{"location":"tutorials/tutorial_continuation_pf/#Run-Small-Signal-Analysis-besides-the-Continuation-Power-Flow","page":"Small-Signal Analysis","title":"Run Small-Signal Analysis besides the Continuation Power Flow","text":"","category":"section"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"To run a small-signal analysis we require a dynamic model of the machine. We can use PowerSystemCaseBuilder to the load the same system, but with a dynamic model for the generator, including a GENROU + SEXS exciter + TGOV1 governor.","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"sys = build_system(PSIDSystems, \"2 Bus Load Tutorial GENROU\")","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"Here are the components of the generator:","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"first(get_components(DynamicGenerator, sys))","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"Besides the results of the P-V curve, we need to store if the system is small-signal stable or not by looking if there is a positive real part eigenvalue.","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"# Vectors to store stability using a boolean (true for stable).\nstable_vec = Vector{Bool}();\nstatus_vec = Vector{Bool}();\n\n# PV Curve Results\nP_load_p = Vector{Float64}();\nV_load_p = Vector{Float64}();","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"We then run the main for loop by updating the load active power, but in addition we create a PowerSimulationsDynamics simulation on which we can run a small-signal analysis to check stability.","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"for p in P_range\n # Change the active power and reactive power of the load\n power = p * 1.0\n load = get_component(PSY.ExponentialLoad, sys_static, \"load1021\")\n set_active_power!(load, power)\n q_power = power * tan(acos(load_pf))\n set_reactive_power!(load, q_power)\n # Run Power Flow\n status = solve_ac_powerflow!(sys_static)\n if !status\n # Finish the loop if the power flow fails\n print(\"Power Flow failed at p = $(power)\")\n break\n end\n # Obtain the bus voltage information\n bus = get_component(Bus, sys_static, \"BUS 2\")\n Vm = get_magnitude(bus)\n # Store values in the vectors\n push!(V_load_p, Vm)\n push!(P_load_p, power)\n\n # Update Load Power in the GENROU system\n load = get_component(PSY.ExponentialLoad, sys, \"load1021\")\n set_active_power!(load, power)\n q_power = power * tan(acos(load_pf))\n set_reactive_power!(load, q_power)\n # Construct Simulation\n sim = Simulation(ResidualModel, sys, mktempdir(), (0.0, 1.0))\n if sim.status == PSID.BUILT\n # Check small-signal stability\n sm = small_signal_analysis(sim).stable\n # Push results of small-signal stability\n push!(stable_vec, sm)\n # Push results if the simulation was able to be constructed\n push!(status_vec, true)\n else\n # Push results if the simulation was not able to be constructed\n push!(status_vec, false)\n end\nend","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"The following plot showcases the P-V curve, while also showcasing (in red) the regions on which the system is small-signal stable.","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"\n# Find where is stable and unstable\ndict_true_ixs_p = Vector();\ndict_false_ixs_p = Vector();\ndict_true_ixs_p = findall(x->x, stable_vec);\ndict_false_ixs_p = findall(x->!x, stable_vec);\n\n# Create plot\ntrue_ixs = dict_true_ixs_p;\nplot(P_load_p, V_load_p, color = :blue, label = \"PV Curve\", xlabel = \"Load Power [pu]\", ylabel = \"Load Bus Voltage [pu]\")\nplot!(Plots.scatter!(P_load_p[true_ixs] , V_load_p[true_ixs], markerstrokewidth= 0, label = \"GENROU SSA\"))","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"(Image: plot)","category":"page"},{"location":"tutorials/tutorial_continuation_pf/","page":"Small-Signal Analysis","title":"Small-Signal Analysis","text":"This results is consistent with most of the literature for dynamic generator models supplying constant power loads, on which by increasing the active power of the load, produce critical eigenvalues which cross the jomega axis at some point. This is called a Hopf Bifurcation, in this case a subcritical one since the limit cycles are unstable.","category":"page"},{"location":"reference_frames/#Reference-Frames","page":"Reference Frames","title":"Reference Frames","text":"","category":"section"},{"location":"reference_frames/","page":"Reference Frames","title":"Reference Frames","text":"Each dynamic device is defined in its own dq synchronous reference frame (SRF). It is important to note that there are several conventions to do reference frame transformations.","category":"page"},{"location":"reference_frames/#Synchronous-Machines","page":"Reference Frames","title":"Synchronous Machines","text":"","category":"section"},{"location":"reference_frames/","page":"Reference Frames","title":"Reference Frames","text":"The grid is modeled in its own real-imaginary (RI) reference frame. With such, this follows the standard convention that for a voltage angle theta = 0, there is no imaginary part and hence v_h = v_r + j0. Traditionally, the reference frame dq with rotor angle delta for synchronous machines connected to a bus v_hangle theta = v_r + jv_i follows the following convention for transformation of per-unit RMS phasors:","category":"page"},{"location":"reference_frames/","page":"Reference Frames","title":"Reference Frames","text":"beginalign\nv_d + jv_q = (v_r + jv_i) e^-j(delta- pi2) tag1a \nv_d = v_h sin(delta - theta) tag1b \nv_q = v_h cos(delta - theta) tag1c \nleft beginarrayc v_d v_q endarray right = left beginarraycc sin(delta) -cos(delta) cos(delta) sin(delta) endarray right left beginarrayc v_r v_i endarray right tag1d\nendalign","category":"page"},{"location":"reference_frames/","page":"Reference Frames","title":"Reference Frames","text":"Note that hence in a bus of 10angle 0, a rotor angle of delta = 0 implies that v_q = 10 and v_d = 00. This transformation is the one that can be found in most books of Power Systems, such as Kundur, Sauer Pai and in Milano too, and is the convention used in the software to model dynamic models of synchronous machines in their own reference frame.","category":"page"},{"location":"reference_frames/#Inverters","page":"Reference Frames","title":"Inverters","text":"","category":"section"},{"location":"reference_frames/","page":"Reference Frames","title":"Reference Frames","text":"The previously convention is not the standard one used for modeling inverters. Most of inverter and phase-lock loop (PLL) models follow the next convention:","category":"page"},{"location":"reference_frames/","page":"Reference Frames","title":"Reference Frames","text":"beginalign\nv_d + jv_q = (v_r + jv_i) e^-j delta tag2a \nv_d = v_h cos(delta - theta) tag2b \nv_q = -v_h sin(delta - theta) tag2c\nendalign","category":"page"},{"location":"reference_frames/","page":"Reference Frames","title":"Reference Frames","text":"That, contrary to the previous case, when delta = theta = 0 implies that v_d = 10 and v_q = 00. This yields the typical PLL conditions that steer v_q to 0 when delta locks in theta, or when both SRF lock between each other.","category":"page"},{"location":"reference_frames/#Transformation-used","page":"Reference Frames","title":"Transformation used","text":"","category":"section"},{"location":"reference_frames/","page":"Reference Frames","title":"Reference Frames","text":"Given the predominancy of both convention in current work, the software uses both conventions depending on the device modeled. For synchronous machines we used the standard convention (1a)-(1d), while for inverter models we use the predominant convention used nowadays in such models, i.e. (2a)-(2c).","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/#Inverter-Modeling-simulation","page":"Inverter Modeling","title":"Inverter Modeling simulation","text":"","category":"section"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"Originally Contributed by: José Daniel Lara","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/#Introduction","page":"Inverter Modeling","title":"Introduction","text":"","category":"section"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"This tutorial will introduce the modeling of an inverter with Virtual Inertia in a multi-machine model of the system. We will load the data directly from PSS/e dynamic files.","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"The tutorial uses a modified 14-bus system on which all the synchronous machines have been substituted by generators with ESAC1A AVR's and no Turbine Governors.","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"In the first portion of the tutorial we will simulate the system with the original data and cause a line trip between Buses 2 and 4. In the second part of the simulation, we will switch generator 6 with a battery using an inverter and perform the same fault.","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/#Load-the-packages","page":"Inverter Modeling","title":"Load the packages","text":"","category":"section"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"using PowerSimulationsDynamics\nusing PowerSystemCaseBuilder\nusing PowerSystems\nconst PSY = PowerSystems\nusing PowerFlows\nusing Logging\nusing Sundials\nusing Plots","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"note: Note\nPowerSystemCaseBuilder.jl is a helper library that makes it easier to reproduce examples in the documentation and tutorials. Normally you would pass your local files to create the system data instead of calling the function build_system. For more details visit PowerSystemCaseBuilder Documentation","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"Create the system using PowerSystemCaseBuilder.jl:","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"sys = build_system(PSIDSystems, \"14 Bus Base Case\")","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"PowerSystemCaseBuilder.jl is a helper library that makes it easier to reproduce examples in the documentation and tutorials. Normally you would pass your local files to create the system data.","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"Define Simulation Problem with a 20 second simulation period and the branch trip at t = 1.0:","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"sim = Simulation(\n ResidualModel, #Type of model used\n sys, #system\n mktempdir(), #path for the simulation output\n (0.0, 20.0), #time span\n BranchTrip(1.0, Line, \"BUS 02-BUS 04-i_1\");\n console_level = Logging.Info,\n)","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"Now that the system is initialized, we can verify the system states for potential issues.","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"show_states_initial_value(sim)","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"We execute the simulation with an additional tolerance for the solver set at 1e-8:","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"execute!(sim, IDA(); abstol = 1e-8)","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"Using PowerSimulationsDynamics tools for exploring the results, we can plot all the voltage results for the buses:","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"result = read_results(sim)\np = plot();\nfor b in get_components(ACBus, sys)\n voltage_series = get_voltage_magnitude_series(result, get_number(b))\n plot!(\n p,\n voltage_series;\n xlabel = \"Time\",\n ylabel = \"Voltage Magnitude [pu]\",\n label = \"Bus - $(get_name(b))\",\n );\nend","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"(Image: plot)","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"We can also explore the frequency of the different generators","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"p2 = plot();\nfor g in get_components(ThermalStandard, sys)\n state_series = get_state_series(result, (get_name(g), :ω))\n plot!(\n p2,\n state_series;\n xlabel = \"Time\",\n ylabel = \"Speed [pu]\",\n label = \"$(get_name(g)) - ω\",\n );\nend","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"(Image: plot)","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"It is also possible to explore the small signal stability of this system we created.","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"res = small_signal_analysis(sim)","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/#The-eigenvalues-can-be-explored","page":"Inverter Modeling","title":"The eigenvalues can be explored","text":"","category":"section"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"res.eigenvalues","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/#Modifying-the-system-and-adding-storage","page":"Inverter Modeling","title":"Modifying the system and adding storage","text":"","category":"section"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"Reload the system for this example:","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"sys = build_system(PSIDSystems, \"14 Bus Base Case\")\n\n# We want to remove the generator 6 and the dynamic component attached to it.\nthermal_gen = get_component(ThermalStandard, sys, \"generator-6-1\")\nremove_component!(sys, get_dynamic_injector(thermal_gen))\nremove_component!(sys, thermal_gen)\n\n# We can now define our storage device and add it to the system\nstorage = GenericBattery(\n name = \"Battery\",\n bus = get_component(Bus, sys, \"BUS 06\"),\n available = true,\n prime_mover = PrimeMovers.BA,\n active_power = 0.6,\n reactive_power = 0.16,\n rating = 1.1,\n base_power = 25.0,\n initial_energy = 50.0,\n state_of_charge_limits = (min = 5.0, max = 100.0),\n input_active_power_limits = (min = 0.0, max = 1.0),\n output_active_power_limits = (min = 0.0, max = 1.0),\n reactive_power_limits = (min = -1.0, max = 1.0),\n efficiency = (in = 0.80, out = 0.90),\n)\n\nadd_component!(sys, storage)","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"A good sanity check it running a power flow on the system to make sure all the components are properly scaled and that the system is properly balanced. We can use PowerSystems to perform this check. We can get the results back and perform a sanity check.","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"res = solve_powerflow(ACPowerFlow(), sys)\nres[\"bus_results\"]","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"After verifying that the system works, we can define our inverter dynamics and add it to the battery that has already been stored in the system.","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"inverter = DynamicInverter(\n name = get_name(storage),\n ω_ref = 1.0, # ω_ref,\n converter = AverageConverter(rated_voltage = 138.0, rated_current = 100.0),\n outer_control = OuterControl(\n VirtualInertia(Ta = 2.0, kd = 400.0, kω = 20.0),\n ReactivePowerDroop(kq = 0.2, ωf = 1000.0),\n ),\n inner_control = VoltageModeControl(\n kpv = 0.59, #Voltage controller proportional gain\n kiv = 736.0, #Voltage controller integral gain\n kffv = 0.0, #Binary variable enabling the voltage feed-forward in output of current controllers\n rv = 0.0, #Virtual resistance in pu\n lv = 0.2, #Virtual inductance in pu\n kpc = 1.27, #Current controller proportional gain\n kic = 14.3, #Current controller integral gain\n kffi = 0.0, #Binary variable enabling the current feed-forward in output of current controllers\n ωad = 50.0, #Active damping low pass filter cut-off frequency\n kad = 0.2,\n ),\n dc_source = FixedDCSource(voltage = 600.0),\n freq_estimator = KauraPLL(\n ω_lp = 500.0, #Cut-off frequency for LowPass filter of PLL filter.\n kp_pll = 0.084, #PLL proportional gain\n ki_pll = 4.69, #PLL integral gain\n ),\n filter = LCLFilter(lf = 0.08, rf = 0.003, cf = 0.074, lg = 0.2, rg = 0.01),\n)\nadd_component!(sys, inverter, storage)","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"These are the current system components:","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"sys","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"Define Simulation problem using the same parameters:","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"sim = Simulation(\n ResidualModel, #Type of model used\n sys, #system\n mktempdir(), #path for the simulation output\n (0.0, 20.0), #time span\n BranchTrip(1.0, Line, \"BUS 02-BUS 04-i_1\");\n console_level = Logging.Info,\n)","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"We can verify the small signal stability of the system before running the simulation:","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"res = small_signal_analysis(sim)","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"Exploring the eigenvalues:","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"res.eigenvalues","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"We execute the simulation","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"execute!(sim, IDA(); abstol = 1e-8)","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"Using PowerSimulationsDynamics tools for exploring the results, we can plot all the voltage results for the buses","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"result = read_results(sim)\np = plot();\nfor b in get_components(ACBus, sys)\n voltage_series = get_voltage_magnitude_series(result, get_number(b))\n plot!(\n p,\n voltage_series;\n xlabel = \"Time\",\n ylabel = \"Voltage Magnitude [pu]\",\n label = \"Bus - $(get_name(b))\",\n );\nend","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"(Image: plot)","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"We can also explore the frequency of the different static generators and storage","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"p2 = plot();\nfor g in get_components(ThermalStandard, sys)\n state_series = get_state_series(result, (get_name(g), :ω))\n plot!(\n p2,\n state_series;\n xlabel = \"Time\",\n ylabel = \"Speed [pu]\",\n label = \"$(get_name(g)) - ω\",\n );\nend\nstate_series = get_state_series(result, (\"Battery\", :ω_oc))\nplot!(p2, state_series; xlabel = \"Time\", ylabel = \"Speed [pu]\", label = \"Battery - ω\");","category":"page"},{"location":"tutorials/tutorial_inverter_modeling/","page":"Inverter Modeling","title":"Inverter Modeling","text":"(Image: plot)","category":"page"},{"location":"component_models/dc_source/#DC-Source","page":"DC Sources","title":"DC Source","text":"","category":"section"},{"location":"component_models/dc_source/","page":"DC Sources","title":"DC Sources","text":"This component can be used to model the dynamics of the DC side of the converter.","category":"page"},{"location":"component_models/dc_source/#Fixed-DC-Source-[FixedDCSource]","page":"DC Sources","title":"Fixed DC Source [FixedDCSource]","text":"","category":"section"},{"location":"component_models/dc_source/","page":"DC Sources","title":"DC Sources","text":"This is a model that set the DC voltage to a fixed value v_textdc = v_textdc^textfix.","category":"page"},{"location":"tutorials/tutorial_omib/#One-Machine-against-Infinite-Bus-(OMIB)-Simulation","page":"OMIB","title":"One Machine against Infinite Bus (OMIB) Simulation","text":"","category":"section"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"Originally Contributed by: Rodrigo Henriquez-Auba and José Daniel Lara","category":"page"},{"location":"tutorials/tutorial_omib/#Introduction","page":"OMIB","title":"Introduction","text":"","category":"section"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"This tutorial will introduce you to the functionality of PowerSimulationsDynamics for running power system dynamic simulations.","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"This tutorial presents a simulation of a two-bus system with an infinite bus (represented as a voltage source behind an impedance) at bus 1, and a classic machine on bus 2. The perturbation will be the trip of one of the two circuits (doubling its resistance and impedance) of the line that connects both buses.","category":"page"},{"location":"tutorials/tutorial_omib/#Dependencies","page":"OMIB","title":"Dependencies","text":"","category":"section"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"using PowerSimulationsDynamics\nPSID = PowerSimulationsDynamics\nusing PowerSystemCaseBuilder\nusing PowerSystems\nconst PSY = PowerSystems\nusing Sundials\nusing Plots\ngr()","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"note: Note\nPowerSystemCaseBuilder.jl is a helper library that makes it easier to reproduce examples in the documentation and tutorials. Normally you would pass your local files to create the system data instead of calling the function build_system. For more details visit PowerSystemCaseBuilder Documentation","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"PowerSystems (abbreviated with PSY) is used to properly define the data structure and establish an equilibrium point initial condition with a power flow routine, while Sundials is used to solve the problem defined in PowerSimulationsDynamics.","category":"page"},{"location":"tutorials/tutorial_omib/#Load-the-system","page":"OMIB","title":"Load the system","text":"","category":"section"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"We load the system using PowerSystemCaseBuilder.jl:","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"omib_sys = build_system(PSIDSystems, \"OMIB System\")","category":"page"},{"location":"tutorials/tutorial_omib/#Build-the-simulation-and-initialize-the-problem","page":"OMIB","title":"Build the simulation and initialize the problem","text":"","category":"section"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"The next step is to create the simulation structure. This will create the indexing of our system that will be used to formulate the differential-algebraic system of equations. To do so, it is required to specify the perturbation that will occur in the system. PowerSimulationsDynamics supports multiple types of perturbations. See Perturbations","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"Here, we will use a Branch Trip perturbation, that is modeled by modifying the specifying which line we want to trip. In this case we disconnect one of the lines that connects BUS 1 and BUS 2, named \"BUS 1-BUS 2-i_1\".","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"With this, we are ready to create our simulation structure:","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"time_span = (0.0, 30.0)\nperturbation_trip = BranchTrip(1.0, Line, \"BUS 1-BUS 2-i_1\")\nsim = PSID.Simulation(\n ResidualModel, # Type of formulation\n omib_sys, # System\n mktempdir(), # Output directory\n time_span,\n perturbation_trip)","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"This will automatically initialize the system by running a power flow and update V_ref, P_ref and hence eq_p (the internal voltage) to match the solution of the power flow. It will also initialize the states in the equilibrium, which can be printed with:","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"show_states_initial_value(sim)","category":"page"},{"location":"tutorials/tutorial_omib/#Run-the-Simulation","page":"OMIB","title":"Run the Simulation","text":"","category":"section"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"Finally, to run the simulation we simply use:","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"execute!(\n sim, #simulation structure\n IDA(), #Sundials DAE Solver\n dtmax = 0.02, #Arguments: Maximum timestep allowed\n);","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"In some cases, the dynamic time step used for the simulation may fail. In such case, the keyword argument dtmax can be used to limit the maximum time step allowed for the simulation.","category":"page"},{"location":"tutorials/tutorial_omib/#Exploring-the-solution","page":"OMIB","title":"Exploring the solution","text":"","category":"section"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"First, we need to load the simulation results into memory:","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"results = read_results(sim)","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"PowerSimulationsDynamics has two functions to obtain different states of the solution:","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"get_state_series(results, (\"generator-102-1\", :δ)): can be used to obtain the solution as a tuple of time and the required state. In this case, we are obtaining the rotor angle :δ of the generator named \"generator-102-1\"`.","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"angle = get_state_series(results, (\"generator-102-1\", :δ));\nplot(angle, xlabel = \"time\", ylabel = \"rotor angle [rad]\", label = \"rotor angle\")","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"(Image: plot)","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"get_voltage_magnitude_series(results, 102): can be used to obtain the voltage magnitude as a tuple of time and voltage. In this case, we are obtaining the voltage magnitude at bus 102 (where the generator is located).","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"volt = get_voltage_magnitude_series(results, 102);\nplot(volt, xlabel = \"time\", ylabel = \"Voltage [pu]\", label = \"V_2\")","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"(Image: plot)","category":"page"},{"location":"tutorials/tutorial_omib/#Optional:-Small-Signal-Analysis","page":"OMIB","title":"Optional: Small Signal Analysis","text":"","category":"section"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"PowerSimulationsDynamics uses automatic differentiation to compute the reduced Jacobian of the system for the differential states. This can be used to analyze the local stability of the linearized system. We need to re-initialize our simulation:","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"sim2 = Simulation(ResidualModel, omib_sys, mktempdir(), time_span)\nsmall_sig = small_signal_analysis(sim2)","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"The small_sig result can report the reduced jacobian for delta and omega,","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"small_sig.reduced_jacobian","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"and can also be used to report the eigenvalues of the reduced linearized system:","category":"page"},{"location":"tutorials/tutorial_omib/","page":"OMIB","title":"OMIB","text":"small_sig.eigenvalues","category":"page"},{"location":"api/internal/#Internal","page":"Internal API Reference","title":"Internal","text":"","category":"section"},{"location":"api/internal/","page":"Internal API Reference","title":"Internal API Reference","text":"CurrentModule = PowerSimulationsDynamics\nDocTestSetup = quote\n using PowerSimulationsDynamics\nend","category":"page"},{"location":"api/internal/","page":"Internal API Reference","title":"Internal API Reference","text":"Modules = [PowerSimulationsDynamics]\nPublic = false\nPrivate = true","category":"page"},{"location":"api/internal/#PowerSimulationsDynamics.BUILD_STATUS","page":"Internal API Reference","title":"PowerSimulationsDynamics.BUILD_STATUS","text":"Defines the status of the simulation object\n\n\n\n\n\n","category":"type"},{"location":"api/internal/#PowerSimulationsDynamics.BranchWrapper","page":"Internal API Reference","title":"PowerSimulationsDynamics.BranchWrapper","text":"Wraps DynamicBranch devices from PowerSystems to handle changes in controls and connection status, and allocate the required indexes of the state space.\n\n\n\n\n\n","category":"type"},{"location":"api/internal/#PowerSimulationsDynamics.DynamicWrapper","page":"Internal API Reference","title":"PowerSimulationsDynamics.DynamicWrapper","text":"Wraps DynamicInjection devices from PowerSystems to handle changes in controls and connection status, and allocate the required indexes of the state space.\n\n\n\n\n\n","category":"type"},{"location":"api/internal/#PowerSimulationsDynamics.SimulationInputs-Tuple{Type{MassMatrixModel}, System, Union{ConstantFrequency, ReferenceBus}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.SimulationInputs","text":"SimulationInputs build function for MassMatrixModels\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.SimulationInputs-Tuple{Type{ResidualModel}, System, Union{ConstantFrequency, ReferenceBus}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.SimulationInputs","text":"SimulationInputs build function for ResidualModels\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.generator_inner_vars","page":"Internal API Reference","title":"PowerSimulationsDynamics.generator_inner_vars","text":"Generator Inner Vars:\n\nτe_var :: Electric torque\nτm_var :: Mechanical torque\nVf_var :: Field voltage\nV_pss_var :: Additional PSS voltage\nVR_gen_var :: Real part of the terminal voltage\nVI_gen_var :: Imaginary part of the terminal voltage\nψd_var :: Stator Flux (if defined) in the d-axis\nψq_var :: Stator Flux (if defined) in the q-axis\n\n\n\n\n\n","category":"type"},{"location":"api/internal/#PowerSimulationsDynamics.inverter_inner_vars","page":"Internal API Reference","title":"PowerSimulationsDynamics.inverter_inner_vars","text":"Inverter Inner Vars:\n\nmd_var :: Modulation signal on the d-component\nmq_var :: Modulation signal on the q-component\nVdc_var :: DC voltage supplied by the DC source\nVr_filter_var :: Voltage seen in the capacitor of the filter in the R-component\nVi_filter_var :: Voltage seen in the capacitor of the filter in the I-component\nθ_freq_estimator_var :: Angle estimated by the frequency estimator.\nω_freq_estimator_var :: Frequency estimated by the frequency estimator.\nV_oc_var :: Control voltage reference in the d-axis supplied from the outer loop control to the inner loop (for Voltage Mode Control)\nId_oc_var :: Control current reference in the d-axis supplied from the outer loop control to the inner loop (for Current Mode Control)\nIq_oc_var :: Control current reference in the q-axis supplied from the outer loop control to the inner loop (for Current Mode Control)\nId_ic_var :: Control current reference in the d-axis supplied from the inner loop control to the converter (for Generic Models)\nIq_ic_var :: Control current reference in the q-axis supplied from the inner loop control to the converter (for Generic Models)\nIr_cnv_var :: Control current reference in the R-axis supplied from the converter to the filter (for Generic Models)\nIi_cnv_var :: Control current reference in the I-axis supplied from the converter to the filter (for Generic Models)\nω_oc_var :: Control frequency supplied from the outer loop control the inner loop\nθ_oc_var :: Variation of the angle (PLL or VSM) of the inverter\nVr_inv_var :: Real terminal voltage on the inverter\nVi_inv_var :: Imaginary terminal voltage on the inverter\nVr_cnv_var :: Voltage supplied from the converter in the R-component\nVi_cnv_var :: Voltage supplied from the converter in the I-component\nP_ES_var :: Power supplied from the Energy Source side\n\n\n\n\n\n","category":"type"},{"location":"api/internal/#PowerSimulationsDynamics._field_current-Tuple{SalientPoleExponential, String, Vector{Float64}, Vector{Float64}, SimulationResults, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._field_current","text":"Function to obtain the field current time series of a Dynamic Generator with machine type GENSAE.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._field_current-Tuple{SalientPoleQuadratic, String, Vector{Float64}, Vector{Float64}, SimulationResults, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._field_current","text":"Function to obtain the field current time series of a Dynamic Generator with machine type GENSAL.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._field_current-Union{Tuple{M}, Tuple{M, String, Vector{Float64}, Vector{Float64}, SimulationResults, Union{Nothing, Float64}}} where M<:Machine","page":"Internal API Reference","title":"PowerSimulationsDynamics._field_current","text":"Function to obtain the field current time series of a Dynamic Generator. It is dispatched via the machine type. By default, machine does not have support for field current\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._field_current-Union{Tuple{M}, Tuple{M, String, Vector{Float64}, Vector{Float64}, SimulationResults, Union{Nothing, Float64}}} where M<:Union{RoundRotorExponential, RoundRotorQuadratic}","page":"Internal API Reference","title":"PowerSimulationsDynamics._field_current","text":"Function to obtain the field current time series of a Dynamic Generator with machine type GENROU/GENROE.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._field_voltage-Tuple{AVRFixed, String, SimulationResults, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._field_voltage","text":"Function to obtain the field voltage time series of a Dynamic Generator with avr AVRFixed.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._field_voltage-Tuple{ESST1A, String, SimulationResults, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._field_voltage","text":"Function to obtain the field voltage time series of a Dynamic Generator with avr ESST1A.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._field_voltage-Tuple{SCRX, String, SimulationResults, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._field_voltage","text":"Function to obtain the field voltage time series of a Dynamic Generator with avr SCRX.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._field_voltage-Tuple{Union{ESAC1A, EXAC1}, String, SimulationResults, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._field_voltage","text":"Function to obtain the field voltage time series of a Dynamic Generator with avr ESAC1A and EXAC1.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._field_voltage-Union{Tuple{A}, Tuple{A, String, SimulationResults, Union{Nothing, Float64}}} where A<:AVR","page":"Internal API Reference","title":"PowerSimulationsDynamics._field_voltage","text":"Function to obtain the field voltage time series of a Dynamic Generator with avrs that have the field voltage as a state. By default it is assumed that the models have that state.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._frequency-Union{Tuple{G}, Tuple{F}, Tuple{OuterControl{ActivePowerDroop, ReactivePowerDroop}, F, String, SimulationResults, G, Union{Nothing, Float64}}} where {F<:FrequencyEstimator, G<:DynamicInverter}","page":"Internal API Reference","title":"PowerSimulationsDynamics._frequency","text":"Function to obtain the frequency time series of a droop grid forming inverter out of the DAE Solution. It is dispatched via the OuterControl type.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._frequency-Union{Tuple{G}, Tuple{F}, Tuple{OuterControl{ActiveVirtualOscillator, ReactiveVirtualOscillator}, F, String, SimulationResults, G, Union{Nothing, Float64}}} where {F<:FrequencyEstimator, G<:DynamicInverter}","page":"Internal API Reference","title":"PowerSimulationsDynamics._frequency","text":"Function to obtain the frequency time series of a VOC grid forming inverter out of the DAE Solution. It is dispatched via the OuterControl type.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._frequency-Union{Tuple{G}, Tuple{F}, Tuple{OuterControl{VirtualInertia, ReactivePowerDroop}, F, String, SimulationResults, G, Union{Nothing, Float64}}} where {F<:FrequencyEstimator, G<:DynamicInverter}","page":"Internal API Reference","title":"PowerSimulationsDynamics._frequency","text":"Function to obtain the frequency time series of a virtual inertia grid forming inverter out of the DAE Solution. It is dispatched via the OuterControl type.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._frequency-Union{Tuple{G}, Tuple{OuterControl{ActivePowerPI, ReactivePowerPI}, KauraPLL, String, SimulationResults, G, Union{Nothing, Float64}}} where G<:DynamicInverter","page":"Internal API Reference","title":"PowerSimulationsDynamics._frequency","text":"Function to obtain the frequency time series of a grid-following inverter with KauraPLL out of the DAE Solution. It is dispatched via the OuterControl and FrequencyEstimator type.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._frequency-Union{Tuple{G}, Tuple{OuterControl{ActivePowerPI, ReactivePowerPI}, ReducedOrderPLL, String, SimulationResults, G, Union{Nothing, Float64}}} where G<:DynamicInverter","page":"Internal API Reference","title":"PowerSimulationsDynamics._frequency","text":"Function to obtain the frequency time series of a grid-following inverter with ReducedOrderPLL out of the DAE Solution. It is dispatched via the OuterControl and FrequencyEstimator type.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._machine_current-Tuple{BaseMachine, String, Vector{Float64}, Vector{Float64}, Float64, SimulationResults, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._machine_current","text":"Function to obtain the output current time series of a Classic Machine model out of the DAE Solution. It is dispatched via the machine type.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._machine_current-Tuple{OneDOneQMachine, String, Vector{Float64}, Vector{Float64}, Float64, SimulationResults, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._machine_current","text":"Function to obtain the output current time series of a One-D-One-Q model out of the DAE Solution. It is dispatched via the machine type.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._machine_current-Tuple{SauerPaiMachine, String, Vector{Float64}, Vector{Float64}, Float64, SimulationResults, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._machine_current","text":"Function to obtain the output current time series of a SauerPaiMachine model out of the DAE Solution. It is dispatched via the machine type.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._machine_current-Tuple{Union{AndersonFouadMachine, MarconatoMachine}, String, Vector{Float64}, Vector{Float64}, Float64, SimulationResults, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._machine_current","text":"Function to obtain the output current time series of a Marconato or AndersonFouad model out of the DAE Solution. It is dispatched via the machine type.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._machine_current-Tuple{Union{RoundRotorExponential, RoundRotorQuadratic}, String, Vector{Float64}, Vector{Float64}, Float64, SimulationResults, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._machine_current","text":"Function to obtain the output current time series of a GENROU/GENROE model out of the DAE Solution. It is dispatched via the machine type.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._machine_current-Tuple{Union{SalientPoleExponential, SalientPoleQuadratic}, String, Vector{Float64}, Vector{Float64}, Float64, SimulationResults, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._machine_current","text":"Function to obtain the output current time series of a GENSAL/GENSAE model out of the DAE Solution. It is dispatched via the machine type.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._machine_current-Tuple{Union{SimpleAFMachine, SimpleMarconatoMachine}, String, Vector{Float64}, Vector{Float64}, Float64, SimulationResults, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._machine_current","text":"Function to obtain the output current time series of a SimpleMarconato or SimpleAndersonFouad model out of the DAE Solution. It is dispatched via the machine type.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._make_reduced_jacobian_index-Tuple{Any, Any}","page":"Internal API Reference","title":"PowerSimulationsDynamics._make_reduced_jacobian_index","text":"Finds the location of the differential states in the reduced Jacobian\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._mechanical_torque-Tuple{GasTG, String, SimulationResults, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._mechanical_torque","text":"Function to obtain the mechanical torque time series of a Dynamic Generator with GasTG (GAST) Turbine Governor.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._mechanical_torque-Tuple{HydroTurbineGov, String, SimulationResults, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._mechanical_torque","text":"Function to obtain the mechanical torque time series of a Dynamic Generator with HydroTurbineGov (HYGOV) Turbine Governor.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._mechanical_torque-Tuple{SteamTurbineGov1, String, SimulationResults, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._mechanical_torque","text":"Function to obtain the mechanical torque time series of a Dynamic Generator with SteamTurbineGov1 (TGOV1) Turbine Governor.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._mechanical_torque-Tuple{TGFixed, String, SimulationResults, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._mechanical_torque","text":"Function to obtain the mechanical torque time series of a Dynamic Generator with TGFixed Turbine Governor.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._mechanical_torque-Tuple{TGTypeI, String, SimulationResults, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._mechanical_torque","text":"Function to obtain the mechanical torque time series of a Dynamic Generator with TGTypeI Turbine Governor.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._mechanical_torque-Tuple{TGTypeII, String, SimulationResults, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._mechanical_torque","text":"Function to obtain the mechanical torque time series of a Dynamic Generator with TGTypeII Turbine Governor.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._output_current-Union{Tuple{G}, Tuple{C}, Tuple{LCLFilter, C, String, Vector{Float64}, Vector{Float64}, Float64, SimulationResults, G, Union{Nothing, Float64}}} where {C<:Converter, G<:DynamicInverter}","page":"Internal API Reference","title":"PowerSimulationsDynamics._output_current","text":"Function to obtain the output current time series of a LCL Filter model out of the DAE Solution. It is dispatched via the Filter type.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._output_current-Union{Tuple{G}, Tuple{RLFilter, RenewableEnergyConverterTypeA, String, Vector{Float64}, Vector{Float64}, Float64, SimulationResults, G, Union{Nothing, Float64}}} where G<:DynamicInverter","page":"Internal API Reference","title":"PowerSimulationsDynamics._output_current","text":"Function to obtain the output current time series of a REGCA converter model out of the DAE Solution. It is dispatched via the Converter type.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._post_proc_state_series-Tuple{Any, Int64, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._post_proc_state_series","text":"Internal function to obtain as a Vector of Float64 of a specific state. It receives the solution and the global index for a state.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._pss_output-Tuple{IEEEST, String, SimulationResults, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._pss_output","text":"Function to obtain the pss output time series of a Dynamic Generator with pss IEEEST.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics._pss_output-Tuple{PSSFixed, String, SimulationResults, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics._pss_output","text":"Function to obtain the pss output time series of a Dynamic Generator with pss PSSFixed.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.compute_field_current-Union{Tuple{G}, Tuple{SimulationResults, G, Vector{Float64}, Vector{Float64}, Union{Nothing, Float64}}} where G<:DynamicGenerator","page":"Internal API Reference","title":"PowerSimulationsDynamics.compute_field_current","text":"Function to obtain the field current time series of a Dynamic Generator model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. It is dispatched for device type to compute the specific current.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.compute_field_current-Union{Tuple{G}, Tuple{SimulationResults, G, Vector{Float64}, Vector{Float64}, Union{Nothing, Float64}}} where G<:DynamicInverter","page":"Internal API Reference","title":"PowerSimulationsDynamics.compute_field_current","text":"Function to obtain the field current time series of a Dynamic Inverter model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. It must return nothing since field current does not exists in inverters.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.compute_field_voltage-Union{Tuple{G}, Tuple{SimulationResults, G, Union{Nothing, Float64}}} where G<:DynamicGenerator","page":"Internal API Reference","title":"PowerSimulationsDynamics.compute_field_voltage","text":"Function to obtain the field voltage time series of a Dynamic Generator model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. It is dispatched for device type to compute the specific voltage.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.compute_field_voltage-Union{Tuple{G}, Tuple{SimulationResults, G, Union{Nothing, Float64}}} where G<:DynamicInverter","page":"Internal API Reference","title":"PowerSimulationsDynamics.compute_field_voltage","text":"Function to obtain the field current time series of a Dynamic Inverter model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. It must return nothing since field voltage does not exists in inverters.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.compute_frequency-Union{Tuple{G}, Tuple{SimulationResults, G, Union{Nothing, Float64}}} where G<:DynamicGenerator","page":"Internal API Reference","title":"PowerSimulationsDynamics.compute_frequency","text":"Function to obtain the output frequency time series of a DynamicGenerator\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.compute_mechanical_torque-Union{Tuple{G}, Tuple{SimulationResults, G, Union{Nothing, Float64}}} where G<:DynamicGenerator","page":"Internal API Reference","title":"PowerSimulationsDynamics.compute_mechanical_torque","text":"Function to obtain the mechanical torque time series of a Dynamic Generator model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. It is dispatched for device type to compute the specific torque.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.compute_mechanical_torque-Union{Tuple{G}, Tuple{SimulationResults, G, Union{Nothing, Float64}}} where G<:DynamicInverter","page":"Internal API Reference","title":"PowerSimulationsDynamics.compute_mechanical_torque","text":"Function to obtain the mechanical torque time series of a Dynamic Inverter model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. It must return nothing since mechanical torque is not used in inverters.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.compute_output_current-Tuple{SimulationResults, AggregateDistributedGenerationA, Vector{Float64}, Vector{Float64}, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.compute_output_current","text":"Function to obtain the output current time series of a AggregateDistributedGenerationA (DERA) model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.compute_output_current-Tuple{SimulationResults, PeriodicVariableSource, Vector{Float64}, Vector{Float64}, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.compute_output_current","text":"Function to obtain the output current time series of a PeriodicVariableSource model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. It is dispatched for device type to compute the specific current. computeoutputcurrent(::SimulationResults, ::PeriodicVariableSource, ::Vector{Float64}, ::Vector{Float64}, ::Nothing)\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.compute_output_current-Tuple{SimulationResults, PowerLoad, Vector{Float64}, Vector{Float64}, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.compute_output_current","text":"Function to obtain the output current time series of a PowerLoad model. \n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.compute_output_current-Tuple{SimulationResults, PowerSystems.ExponentialLoad, Vector{Float64}, Vector{Float64}, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.compute_output_current","text":"Function to obtain the output current time series of a ExponentialLoad model. \n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.compute_output_current-Tuple{SimulationResults, SimplifiedSingleCageInductionMachine, Vector{Float64}, Vector{Float64}, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.compute_output_current","text":"Function to obtain the output current time series of a 3th Order Induction Machine model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. \n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.compute_output_current-Tuple{SimulationResults, SingleCageInductionMachine, Vector{Float64}, Vector{Float64}, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.compute_output_current","text":"Function to obtain the output current time series of a 5th Order Induction Machine model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. \n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.compute_output_current-Tuple{SimulationResults, StandardLoad, Vector{Float64}, Vector{Float64}, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.compute_output_current","text":"Function to obtain the output current time series of a PowerLoad model. \n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.compute_output_current-Union{Tuple{G}, Tuple{SimulationResults, G, Vector{Float64}, Vector{Float64}, Union{Nothing, Float64}}} where G<:DynamicGenerator","page":"Internal API Reference","title":"PowerSimulationsDynamics.compute_output_current","text":"Function to obtain the output current time series of a Dynamic Generator model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. It is dispatched for device type to compute the specific current.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.compute_output_current-Union{Tuple{G}, Tuple{SimulationResults, G, Vector{Float64}, Vector{Float64}, Union{Nothing, Float64}}} where G<:DynamicInverter","page":"Internal API Reference","title":"PowerSimulationsDynamics.compute_output_current","text":"Function to obtain the output current time series of a Dynamic Inverter model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. It is dispatched for device type to compute the specific current.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.compute_output_current-Union{Tuple{I}, Tuple{SimulationResults, I, Vector{Float64}, Vector{Float64}, Union{Nothing, Float64}}} where I<:DynamicInjection","page":"Internal API Reference","title":"PowerSimulationsDynamics.compute_output_current","text":"Default function to compute output current. Returns an error\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.compute_pss_output-Union{Tuple{G}, Tuple{SimulationResults, G, Union{Nothing, Float64}}} where G<:DynamicGenerator","page":"Internal API Reference","title":"PowerSimulationsDynamics.compute_pss_output","text":"Function to obtain the pss output time series of a Dynamic Generator model out of the DAE Solution. It receives the simulation inputs, the dynamic device and bus voltage. It is dispatched for device type to compute the specific output.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.configure_logging-Tuple{}","page":"Internal API Reference","title":"PowerSimulationsDynamics.configure_logging","text":"configure_logging(;\n console_level = Logging.Error,\n file_level = Logging.Info,\n filename = \"power-simulations.log\",\n)\n\nCreates console and file loggers.\n\nNote: Log messages may not be written to the file until flush() or close() is called on the returned logger.\n\nArguments\n\nconsole_level = Logging.Error: level for console messages\nfile_level = Logging.Info: level for file messages\nfilename::String = power-simulations.log: log file\n\nExample\n\nlogger = configure_logging(console_level = Logging.Info)\n@info \"log message\"\nclose(logger)\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.device!-Union{Tuple{T}, Tuple{AbstractArray{T}, AbstractArray{T}, T, T, AbstractArray{T}, AbstractArray{T}, AbstractArray{T}, AbstractArray{T}, PowerSimulationsDynamics.DynamicWrapper{ActiveConstantPowerLoad}, Any}} where T<:Union{Float64, ForwardDiff.Dual}","page":"Internal API Reference","title":"PowerSimulationsDynamics.device!","text":"Model of 12-state Active Constant Power Load in Julia. Based on the paper Malicious Control of an Active Load in an Islanded Mixed-Source Microgrid by C. Roberts, U. Markovic, D. Arnold and D. Callaway.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.device!-Union{Tuple{T}, Tuple{AbstractArray{T}, AbstractArray{T}, T, T, AbstractArray{T}, AbstractArray{T}, AbstractArray{T}, AbstractArray{T}, PowerSimulationsDynamics.DynamicWrapper{CSVGN1}, Any}} where T<:Union{Float64, ForwardDiff.Dual}","page":"Internal API Reference","title":"PowerSimulationsDynamics.device!","text":"Model of Static Shunt Compensator: CSVGN1.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.device!-Union{Tuple{T}, Tuple{AbstractArray{T}, AbstractArray{T}, T, T, AbstractArray{T}, AbstractArray{T}, AbstractArray{T}, AbstractArray{T}, PowerSimulationsDynamics.DynamicWrapper{SimplifiedSingleCageInductionMachine}, Any}} where T<:Union{Float64, ForwardDiff.Dual}","page":"Internal API Reference","title":"PowerSimulationsDynamics.device!","text":"Model of 3-state (SimplifiedSingleCageInductionMachine) induction motor in Julia. Based on the 3rd order model derived in Prabha Kundur's Book and the equations in \"Analysis of Electric Machinery and Drive Systems\" by Paul Krause, Oleg Wasynczuk and Scott Sudhoff.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.device!-Union{Tuple{T}, Tuple{AbstractArray{T}, AbstractArray{T}, T, T, AbstractArray{T}, AbstractArray{T}, AbstractArray{T}, AbstractArray{T}, PowerSimulationsDynamics.DynamicWrapper{SingleCageInductionMachine}, Any}} where T<:Union{Float64, ForwardDiff.Dual}","page":"Internal API Reference","title":"PowerSimulationsDynamics.device!","text":"Model of 5-state (SingleCageInductionMachine) induction motor in Julia. Refer to \"Analysis of Electric Machinery and Drive Systems\" by Paul Krause, Oleg Wasynczuk and Scott Sudhoff for the equations\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.initialize_mach_shaft!-Union{Tuple{P}, Tuple{TG}, Tuple{A}, Tuple{S}, Tuple{Any, StaticInjection, PowerSimulationsDynamics.DynamicWrapper{DynamicGenerator{AndersonFouadMachine, S, A, TG, P}}, AbstractVector}} where {S<:Shaft, A<:AVR, TG<:TurbineGov, P<:PSS}","page":"Internal API Reference","title":"PowerSimulationsDynamics.initialize_mach_shaft!","text":"Initialitation of model of 6-state (Anderson-Fouad) synchronous machine in Julia. Refer to Power System Modelling and Scripting by F. Milano for the equations\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.initialize_mach_shaft!-Union{Tuple{P}, Tuple{TG}, Tuple{A}, Tuple{S}, Tuple{Any, StaticInjection, PowerSimulationsDynamics.DynamicWrapper{DynamicGenerator{BaseMachine, S, A, TG, P}}, AbstractVector}} where {S<:Shaft, A<:AVR, TG<:TurbineGov, P<:PSS}","page":"Internal API Reference","title":"PowerSimulationsDynamics.initialize_mach_shaft!","text":"Initialitation of model of 0-state synchronous (classic model) machine in Julia. Refer to Power System Modelling and Scripting by F. Milano for the equations\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.initialize_mach_shaft!-Union{Tuple{P}, Tuple{TG}, Tuple{A}, Tuple{S}, Tuple{Any, StaticInjection, PowerSimulationsDynamics.DynamicWrapper{DynamicGenerator{MarconatoMachine, S, A, TG, P}}, AbstractVector}} where {S<:Shaft, A<:AVR, TG<:TurbineGov, P<:PSS}","page":"Internal API Reference","title":"PowerSimulationsDynamics.initialize_mach_shaft!","text":"Initialitation of model of 6-state (Marconato) synchronous machine in Julia. Refer to Power System Modelling and Scripting by F. Milano for the equations\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.initialize_mach_shaft!-Union{Tuple{P}, Tuple{TG}, Tuple{A}, Tuple{S}, Tuple{Any, StaticInjection, PowerSimulationsDynamics.DynamicWrapper{DynamicGenerator{OneDOneQMachine, S, A, TG, P}}, AbstractVector}} where {S<:Shaft, A<:AVR, TG<:TurbineGov, P<:PSS}","page":"Internal API Reference","title":"PowerSimulationsDynamics.initialize_mach_shaft!","text":"Initialitation of model of 2-state (One d- and One q-) synchronous machine in Julia. Refer to Power System Modelling and Scripting by F. Milano for the equations\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.initialize_mach_shaft!-Union{Tuple{P}, Tuple{TG}, Tuple{A}, Tuple{S}, Tuple{Any, StaticInjection, PowerSimulationsDynamics.DynamicWrapper{DynamicGenerator{SauerPaiMachine, S, A, TG, P}}, AbstractVector}} where {S<:Shaft, A<:AVR, TG<:TurbineGov, P<:PSS}","page":"Internal API Reference","title":"PowerSimulationsDynamics.initialize_mach_shaft!","text":"Initialitation of model of 6-state (SauerPai) synchronous machine in Julia. Refer to Power System Modelling and Scripting by F. Milano for the equations\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.initialize_mach_shaft!-Union{Tuple{P}, Tuple{TG}, Tuple{A}, Tuple{S}, Tuple{Any, StaticInjection, PowerSimulationsDynamics.DynamicWrapper{DynamicGenerator{SimpleAFMachine, S, A, TG, P}}, AbstractVector}} where {S<:Shaft, A<:AVR, TG<:TurbineGov, P<:PSS}","page":"Internal API Reference","title":"PowerSimulationsDynamics.initialize_mach_shaft!","text":"Initialitation of model of 4-state (Simple Anderson-Fouad) synchronous machine in Julia. Refer to Power System Modelling and Scripting by F. Milano for the equations\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.initialize_mach_shaft!-Union{Tuple{P}, Tuple{TG}, Tuple{A}, Tuple{S}, Tuple{Any, StaticInjection, PowerSimulationsDynamics.DynamicWrapper{DynamicGenerator{SimpleMarconatoMachine, S, A, TG, P}}, AbstractVector}} where {S<:Shaft, A<:AVR, TG<:TurbineGov, P<:PSS}","page":"Internal API Reference","title":"PowerSimulationsDynamics.initialize_mach_shaft!","text":"Initialitation of model of 4-state (Simple Marconato) synchronous machine in Julia. Refer to Power System Modelling and Scripting by F. Milano for the equations\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.low_pass_modified_mass_matrix-Union{Tuple{Z}, Tuple{W}, Tuple{V}, Tuple{Z, V, Float64, W, Float64}} where {V<:Union{Float64, ForwardDiff.Dual}, W<:Union{Float64, ForwardDiff.Dual}, Z<:Union{Float64, ForwardDiff.Dual}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.low_pass_modified_mass_matrix","text":"Low Pass Filter Modified ┌─────────────┐ │ K │ u -> │ ────────────│ -> y │ K_den + sT │ └─────────────┘\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.mass_matrix_entries-Tuple{DynamicInjection}","page":"Internal API Reference","title":"PowerSimulationsDynamics.mass_matrix_entries","text":"Default implementation of mass matrix entries. Keeps the default values in the identity matrix\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.mdl_machine_ode!-Union{Tuple{P}, Tuple{TG}, Tuple{A}, Tuple{S}, Tuple{AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, PowerSimulationsDynamics.DynamicWrapper{DynamicGenerator{AndersonFouadMachine, S, A, TG, P}}}} where {S<:Shaft, A<:AVR, TG<:TurbineGov, P<:PSS}","page":"Internal API Reference","title":"PowerSimulationsDynamics.mdl_machine_ode!","text":"Model of 6-state (AndersonFouadMachine) synchronous machine in Julia. Refer to Power System Modelling and Scripting by F. Milano for the equations\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.mdl_machine_ode!-Union{Tuple{P}, Tuple{TG}, Tuple{A}, Tuple{S}, Tuple{AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, PowerSimulationsDynamics.DynamicWrapper{DynamicGenerator{BaseMachine, S, A, TG, P}}}} where {S<:Shaft, A<:AVR, TG<:TurbineGov, P<:PSS}","page":"Internal API Reference","title":"PowerSimulationsDynamics.mdl_machine_ode!","text":"Model of 0-state synchronous machine in Julia. Refer to Power System Modelling and Scripting by F. Milano for the equations\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.mdl_machine_ode!-Union{Tuple{P}, Tuple{TG}, Tuple{A}, Tuple{S}, Tuple{AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, PowerSimulationsDynamics.DynamicWrapper{DynamicGenerator{MarconatoMachine, S, A, TG, P}}}} where {S<:Shaft, A<:AVR, TG<:TurbineGov, P<:PSS}","page":"Internal API Reference","title":"PowerSimulationsDynamics.mdl_machine_ode!","text":"Model of 6-state (MarconatoMachine) synchronous machine in Julia. Refer to Power System Modelling and Scripting by F. Milano for the equations\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.mdl_machine_ode!-Union{Tuple{P}, Tuple{TG}, Tuple{A}, Tuple{S}, Tuple{AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, PowerSimulationsDynamics.DynamicWrapper{DynamicGenerator{OneDOneQMachine, S, A, TG, P}}}} where {S<:Shaft, A<:AVR, TG<:TurbineGov, P<:PSS}","page":"Internal API Reference","title":"PowerSimulationsDynamics.mdl_machine_ode!","text":"Model of 2-state (One d- and One q-) synchronous machine in Julia. Refer to Power System Modelling and Scripting by F. Milano for the equations\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.mdl_machine_ode!-Union{Tuple{P}, Tuple{TG}, Tuple{A}, Tuple{S}, Tuple{AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, PowerSimulationsDynamics.DynamicWrapper{DynamicGenerator{SauerPaiMachine, S, A, TG, P}}}} where {S<:Shaft, A<:AVR, TG<:TurbineGov, P<:PSS}","page":"Internal API Reference","title":"PowerSimulationsDynamics.mdl_machine_ode!","text":"Model of 6-state (SauerPaiMachine) synchronous machine in Julia. Refer to Power System Modelling and Scripting by F. Milano for the equations\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.mdl_machine_ode!-Union{Tuple{P}, Tuple{TG}, Tuple{A}, Tuple{S}, Tuple{AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, PowerSimulationsDynamics.DynamicWrapper{DynamicGenerator{SimpleAFMachine, S, A, TG, P}}}} where {S<:Shaft, A<:AVR, TG<:TurbineGov, P<:PSS}","page":"Internal API Reference","title":"PowerSimulationsDynamics.mdl_machine_ode!","text":"Model of 4-state (SimpleAFMachine) synchronous machine in Julia. Refer to Power System Modelling and Scripting by F. Milano for the equations\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.mdl_machine_ode!-Union{Tuple{P}, Tuple{TG}, Tuple{A}, Tuple{S}, Tuple{AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, AbstractArray{<:Union{Float64, ForwardDiff.Dual}}, PowerSimulationsDynamics.DynamicWrapper{DynamicGenerator{SimpleMarconatoMachine, S, A, TG, P}}}} where {S<:Shaft, A<:AVR, TG<:TurbineGov, P<:PSS}","page":"Internal API Reference","title":"PowerSimulationsDynamics.mdl_machine_ode!","text":"Model of 4-state (SimpleMarconatoMachine) synchronous machine in Julia. Refer to Power System Modelling and Scripting by F. Milano for the equations\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.mdl_zip_load!-Union{Tuple{T}, Tuple{T, T, AbstractArray{T}, AbstractArray{T}, PowerSimulationsDynamics.StaticLoadWrapper}} where T<:Union{Float64, ForwardDiff.Dual}","page":"Internal API Reference","title":"PowerSimulationsDynamics.mdl_zip_load!","text":"Model for ZIP Load model given by:\n\nPzip = Ppower + Pcurrent * (V / V0) + Pimpedance * (V / V0)^2 Qzip = Qpower + Qcurrent * (V / V0) + Qimpedance * (V / V0)^2\n\nwith V = sqrt(Vr^2 + Vi^2) and V0 the voltage magnitude from the power flow solution\n\nThe current taken for the load is computed as: Izip = (Pzip + j Qzip)^* / (Vr + j Vi)^* Izip = (Pzip - j Qzip) / (Vr - j Vi)\n\nFor constant impedance it is obtained: Izre = (1 / V0)^2 * (Vr * Pimpedance + Vi * Qimpedance) Izim = (1 / V0)^2 * (Vi * Pimpedance - Vr * Qimpedance)\n\nFor constant current it is obtained: Iire = (1 / V0) * ( (Vr * Pcurrent + Vi * Qcurrent) / V ) Iiim = (1 / V0) * ( (Vi * Pcurrent - Vr * Qcurrent) / V )\n\nFor constant power it is obtained: Ipre = (Vr * Ppower + Vi * Qpower) / V^2 Ipim = (Vi * Ppower - Vr * Qpower) / V^2\n\nModel for Exponential Load model given by:\n\nPexp = P0 * (V / V0)^α Qexp = Q0 * (V / V0)^β\n\nThe current taken for the load is computed as: Iexp = (Pexp + j Qexp)^* / (Vr + j Vi)^* Iexp = (Pexp - j Qexp) / (Vr - j Vi)\n\nIt results: Irexp = Vr * P0 * (V^(α - 2) / V0^α) + Vi * Q0 * (V^(β - 2)/ V0^β) Iiim = Vi * P0 * (V^(α - 2) / V0^α) - Vr * Q0 * (V^(β - 2)/ V0^β)\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.post_proc_activepower_series-Tuple{SimulationResults, String, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.post_proc_activepower_series","text":"Function to compute the active power output time series of a Dynamic Injection series out of the DAE Solution. It receives the solution and the string name of the Dynamic Injection device.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.post_proc_branch_series-Tuple{SimulationResults, String, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.post_proc_branch_series","text":"Function to compute the current flowing through an AC branch through their series element. The current is computed through the from bus into the to bus.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.post_proc_field_current_series-Tuple{SimulationResults, String, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.post_proc_field_current_series","text":"Function to compute the field current output time series of a Dynamic Injection series out of the DAE Solution. It receives the solution and the string name of the Dynamic Injection device.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.post_proc_field_voltage_series-Tuple{SimulationResults, String, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.post_proc_field_voltage_series","text":"Function to compute the field voltage output time series of a Dynamic Injection series out of the DAE Solution. It receives the solution and the string name of the Dynamic Injection device.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.post_proc_frequency_series-Tuple{SimulationResults, String, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.post_proc_frequency_series","text":"Function to compute the frequency of a Dynamic Injection component.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.post_proc_imaginary_current_series-Tuple{SimulationResults, String, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.post_proc_imaginary_current_series","text":"Function to compute the imaginary current output time series of a Dynamic Injection series out of the DAE Solution. It receives the solution and the string name of the Dynamic Injection device.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.post_proc_mechanical_torque_series-Tuple{SimulationResults, String, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.post_proc_mechanical_torque_series","text":"Function to compute the mechanical torque output time series of a Dynamic Injection series out of the DAE Solution. It receives the solution and the string name of the Dynamic Injection device.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.post_proc_pss_output_series-Tuple{SimulationResults, String, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.post_proc_pss_output_series","text":"Function to compute the pss output time series of a Dynamic Injection series out of the DAE Solution. It receives the solution and the string name of the Dynamic Injection device.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.post_proc_reactivepower_series-Tuple{SimulationResults, String, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.post_proc_reactivepower_series","text":"Function to compute the active power output time series of a Dynamic Injection series out of the DAE Solution. It receives the solution and the string name of the Dynamic Injection device.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.post_proc_real_current_series-Tuple{SimulationResults, String, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.post_proc_real_current_series","text":"Function to compute the real current output time series of a Dynamic Injection series out of the DAE Solution. It receives the solution and the string name of the Dynamic Injection device.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.post_proc_source_voltage_current_series","page":"Internal API Reference","title":"PowerSimulationsDynamics.post_proc_source_voltage_current_series","text":"Function to obtain voltage and output currents for a source. It receives the simulation resutls and an optional argument of the time step of the results.\n\n\n\n\n\n","category":"function"},{"location":"api/internal/#PowerSimulationsDynamics.post_proc_state_series-Tuple{SimulationResults, Tuple{String, Symbol}, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.post_proc_state_series","text":"Function to obtain the state time series of a specific state. It receives the simulation, and a tuple containing the name of the Dynamic Device and the symbol of the state.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.post_proc_voltage_current_series-Tuple{SimulationResults, String, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.post_proc_voltage_current_series","text":"Function to obtain voltage and output currents for a dynamic device. It receives the simulation, and the name of the Dynamic Device.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.post_proc_voltage_series-Tuple{Any, Int64, Int64, Union{Nothing, Float64}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.post_proc_voltage_series","text":"Function to obtain voltage using the bus index (and not the bus number). It receives the solution, the bus index and the total number of buses.\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.saturation_function-Tuple{Union{RoundRotorExponential, SalientPoleExponential}, Union{Float64, ForwardDiff.Dual}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.saturation_function","text":"Saturation function for exponential saturation models for machines\n Se(x) = B * x^A\n\n\n\n\n\n","category":"method"},{"location":"api/internal/#PowerSimulationsDynamics.saturation_function-Tuple{Union{RoundRotorQuadratic, SalientPoleQuadratic}, Union{Float64, ForwardDiff.Dual}}","page":"Internal API Reference","title":"PowerSimulationsDynamics.saturation_function","text":"Saturation function for quadratic saturation models for machines\n Se(x) = B * (x - A)^2 / x\n\n\n\n\n\n","category":"method"},{"location":"component_models/converter/#Converter","page":"Converter","title":"Converter","text":"","category":"section"},{"location":"component_models/converter/","page":"Converter","title":"Converter","text":"This component can be used to model the dynamics of the switching process.","category":"page"},{"location":"component_models/converter/#Average-Model-[AverageConverter]","page":"Converter","title":"Average Model [AverageConverter]","text":"","category":"section"},{"location":"component_models/converter/","page":"Converter","title":"Converter","text":"The average model outputs the desired reference signal since:","category":"page"},{"location":"component_models/converter/","page":"Converter","title":"Converter","text":"beginalign\nv_d^textcv approx m_d v_textdc approx fracv_d^textref-signalv_textdc v_textdc approx v_d^textref-signal tag1a \nv_q^textcv approx m_q v_textdc approx fracv_q^textref-signalv_textdc v_textdc approx v_q^textref-signal tag1b\nendalign","category":"page"},{"location":"component_models/converter/","page":"Converter","title":"Converter","text":"where m_dq is the modulation signal, and v_dq^textref-signal is the voltage reference signal from the inner loop control.","category":"page"},{"location":"component_models/converter/#Generic-Renewable-Converter-Type-A-[RenewableEnergyConverterTypeA]","page":"Converter","title":"Generic Renewable Converter Type A ```[RenewableEnergyConverterTypeA]","text":"","category":"section"},{"location":"component_models/converter/","page":"Converter","title":"Converter","text":"This block represents the REGCA model. The equations (without the limiters) are:","category":"page"},{"location":"component_models/converter/","page":"Converter","title":"Converter","text":"beginalign\n dotI_p = frac1T_g (I_textpcmd - I_p) tag2a \n dotI_q = frac1T_g (I_textqcmd - I_q) tag2b \n dotV_textmeas = frac1T_fltr (V_t - V_textmeas tag2c)\nendalign","category":"page"},{"location":"component_models/converter/","page":"Converter","title":"Converter","text":"on which I_textpcmd and I_textqcmd are the current commands from the inner control and V_t is the bus voltage magnitude. The additional terms and output current are computed as:","category":"page"},{"location":"component_models/converter/","page":"Converter","title":"Converter","text":"beginalign\n I_q^textcv = -I_q - I_textqextra tag2d \n I_textqextra = max(K_hv (V_t - V_textolim)) tag2e \n I_p^textcv = G_lv I_p tag2f \nendalign","category":"page"},{"location":"component_models/converter/","page":"Converter","title":"Converter","text":"on which G_lv is the gain used for Low Voltage Active Current Management and I_textqextra is the additional current for High Voltage Reactive Current Management.","category":"page"},{"location":"component_models/converter/","page":"Converter","title":"Converter","text":"It is important to note that both current commands coming from the inner control were obtained by dividing the active (or reactive) power by the magnitude voltage instead of using the correct phasor formula I = (SV)^*. For that purpose, a correction factor must be applied to obtain the correct output currents in the network reference frame:","category":"page"},{"location":"component_models/converter/","page":"Converter","title":"Converter","text":"beginalign*\n I_r + jI_i = (I_p + jI_q) cdot V_t cdot frac1V_r + jV_i \n = (I_p + jI_q) cdot fracV_tV_t e^jtheta \n = (I_p + jI_q) cdot e^-jtheta\nendalign*","category":"page"},{"location":"component_models/converter/","page":"Converter","title":"Converter","text":"This correction factor looks like a reference transformation that must be used to properly inject current into the grid. With that the output current is computed as:","category":"page"},{"location":"component_models/converter/","page":"Converter","title":"Converter","text":"beginalign\n I_r = I_p^textcv cos(theta) - I_q^textcv sin(theta) tag2g \n I_i = I_p^textcv sin(theta) + I_q^textcv cos(theta) tag2h\nendalign","category":"page"},{"location":"component_models/converter/","page":"Converter","title":"Converter","text":"This current source is usually modeled as a Norton equivalent using a parallel impedance with values R_sorce and X_sorce provided in the .raw file. If an RL filter is used, a Voltage Source behind that RL filter (i.e. the converter output voltage) can be computed as:","category":"page"},{"location":"component_models/converter/","page":"Converter","title":"Converter","text":"beginalign*\n Z_f = r_f + jl_f \n Z_sorce = R_sorce + jX_sorce \n I_cv = I_r + jI_i \n v_r^textcv + jv_i^textcv = fracI_cv + fracv^textgridZ_ffrac1Z_sorce + frac1Z_f tag2i\nendalign*","category":"page"},{"location":"#PowerSimulationsDynamics.jl","page":"Welcome Page","title":"PowerSimulationsDynamics.jl","text":"","category":"section"},{"location":"","page":"Welcome Page","title":"Welcome Page","text":"CurrentModule = PowerSimulationsDynamics","category":"page"},{"location":"#Overview","page":"Welcome Page","title":"Overview","text":"","category":"section"},{"location":"","page":"Welcome Page","title":"Welcome Page","text":"PowerSimulationsDynamics.jl is a Julia package for doing Power Systems Dynamic Modeling with Low Inertia Energy Sources.","category":"page"},{"location":"","page":"Welcome Page","title":"Welcome Page","text":"The synchronous machine components supported here are based on commercial models and the academic components are derived from Power System Modelling and Scripting.","category":"page"},{"location":"","page":"Welcome Page","title":"Welcome Page","text":"Inverter models support both commercial models, such as REPC, REEC and REGC type of models; and academic models obtained from grid-following and grid-forming literature such as in \"A Virtual Synchronous Machine implementation for distributed control of power converters in SmartGrids\"","category":"page"},{"location":"","page":"Welcome Page","title":"Welcome Page","text":"The background work on PowerSimulationsDynamics.jl is explained in Revisiting Power Systems Time-domain Simulation Methods and Models","category":"page"},{"location":"","page":"Welcome Page","title":"Welcome Page","text":"@article{lara2023revisiting,\ntitle={Revisiting Power Systems Time-domain Simulation Methods and Models},\nauthor={Lara, Jose Daniel and Henriquez-Auba, Rodrigo and Ramasubramanian, Deepak and Dhople, Sairaj and Callaway, Duncan S and Sanders, Seth},\njournal={arXiv preprint arXiv:2301.10043},\nyear={2023}\n}","category":"page"},{"location":"#Installation","page":"Welcome Page","title":"Installation","text":"","category":"section"},{"location":"","page":"Welcome Page","title":"Welcome Page","text":"The latest stable release of PowerSimulationsDynamics.jl can be installed using the Julia package manager with","category":"page"},{"location":"","page":"Welcome Page","title":"Welcome Page","text":"] add PowerSimulationsDynamics","category":"page"},{"location":"","page":"Welcome Page","title":"Welcome Page","text":"For the current development version, \"checkout\" this package with","category":"page"},{"location":"","page":"Welcome Page","title":"Welcome Page","text":"] add PowerSimulationsDynamics#master","category":"page"},{"location":"#Structure","page":"Welcome Page","title":"Structure","text":"","category":"section"},{"location":"","page":"Welcome Page","title":"Welcome Page","text":"The following figure shows the interactions between PowerSimulationsDynamics.jl, PowerSystems.jl, ForwardDiff.jl, DiffEqBase.jl and the integrators. The architecture of PowerSimulationsDynamics.jl is such that the power system models are all self-contained and return the model function evaluations. The Jacobian is calculated using automatic differentiation through ForwardDiff.jl, that is used for both numerical integration and small signal analysis. Considering that the resulting models are differential-algebraic equations (DAE), the implementation focuses on the use of implicit solvers, in particular BDF and Rosenbrock methods.","category":"page"},{"location":"","page":"Welcome Page","title":"Welcome Page","text":"","category":"page"},{"location":"","page":"Welcome Page","title":"Welcome Page","text":"⠀","category":"page"},{"location":"","page":"Welcome Page","title":"Welcome Page","text":"","category":"page"},{"location":"","page":"Welcome Page","title":"Welcome Page","text":"PowerSimulationsDynamics.jl has been developed as part of the Scalable Integrated Infrastructure Planning (SIIP) initiative at the U.S. Department of Energy's National Renewable Energy Laboratory (NREL)","category":"page"},{"location":"generic/#Industrial-(Generic)-Renewable-Models","page":"Industrial Renewable Models","title":"Industrial (Generic) Renewable Models","text":"","category":"section"},{"location":"generic/#Connection-with-the-Inverter-Metamodel","page":"Industrial Renewable Models","title":"Connection with the Inverter Metamodel","text":"","category":"section"},{"location":"generic/","page":"Industrial Renewable Models","title":"Industrial Renewable Models","text":"Generic Renewable Models for PV solar or battery devices used in industrial tools, such as PSS/E or PowerWorld, does not necessary resemble the proposed structure of our proposed metamodel. ","category":"page"},{"location":"generic/","page":"Industrial Renewable Models","title":"Industrial Renewable Models","text":"In general terms, a generic renewable model (for PV plant or battery) is typically a Grid Following inverter that uses a Renewable Energy Plant Controller (REPC), a Renewable Energy Electrical Controller (REEC) and a Renewable Energy Generic Converter (REGC) model. The following figure is useful to understand the general structure of such models:","category":"page"},{"location":"generic/","page":"Industrial Renewable Models","title":"Industrial Renewable Models","text":"","category":"page"},{"location":"generic/","page":"Industrial Renewable Models","title":"Industrial Renewable Models","text":"In comparison to the proposed inverter metamodel it is clear that the REPC resembles the Outer Control. However, the REEC has a purpose of both Outer Control and Inner Control and the REGC has a similar purpose of the Converter and Filter in the proposed structure. For such purpose, it was necessary to split the REEC and part of its model was included in both Outer Control and Inner Control.","category":"page"},{"location":"generic/#Example-of-implementation-of-generic-models","page":"Industrial Renewable Models","title":"Example of implementation of generic models","text":"","category":"section"},{"location":"generic/","page":"Industrial Renewable Models","title":"Industrial Renewable Models","text":"The following includes examples of the implementation of the proposed model in the inverter metamodel.","category":"page"},{"location":"generic/#Active-Renewable-Outer-Control","page":"Industrial Renewable Models","title":"Active Renewable Outer Control","text":"","category":"section"},{"location":"generic/","page":"Industrial Renewable Models","title":"Industrial Renewable Models","text":"The following example join the active power controllers from REPCA and REECB as ActiveRenewableControllerAB in PowerSimulationsDynamics.jl","category":"page"},{"location":"generic/","page":"Industrial Renewable Models","title":"Industrial Renewable Models","text":"","category":"page"},{"location":"generic/","page":"Industrial Renewable Models","title":"Industrial Renewable Models","text":"⠀","category":"page"},{"location":"generic/","page":"Industrial Renewable Models","title":"Industrial Renewable Models","text":"An important thing to consider with the industrial models, is that the change of Flags can significantly vary the model and purpose of the controller.","category":"page"},{"location":"generic/#Reactive-Renewable-Outer-Control","page":"Industrial Renewable Models","title":"Reactive Renewable Outer Control","text":"","category":"section"},{"location":"generic/","page":"Industrial Renewable Models","title":"Industrial Renewable Models","text":"Similar to the active controller, the following figure presents the reactive controller part from REPCA and REECB as ReactiveRenewableControllerAB in PowerSimulationsDynamics.jl","category":"page"},{"location":"generic/","page":"Industrial Renewable Models","title":"Industrial Renewable Models","text":"","category":"page"},{"location":"generic/","page":"Industrial Renewable Models","title":"Industrial Renewable Models","text":"⠀","category":"page"},{"location":"generic/#Inner-Controller","page":"Industrial Renewable Models","title":"Inner Controller","text":"","category":"section"},{"location":"generic/","page":"Industrial Renewable Models","title":"Industrial Renewable Models","text":"Finally, the remaining part from REECB was included RECurrentControllerB","category":"page"},{"location":"generic/","page":"Industrial Renewable Models","title":"Industrial Renewable Models","text":"","category":"page"},{"location":"generic/","page":"Industrial Renewable Models","title":"Industrial Renewable Models","text":"⠀","category":"page"},{"location":"generic/","page":"Industrial Renewable Models","title":"Industrial Renewable Models","text":"The REGCAmodel was directly included in a Converter Block, and the filter can be bypassed using an RLFilter block with rf = lf = 0.","category":"page"},{"location":"generic/#Current-availability-of-model-flags-in-PSID","page":"Industrial Renewable Models","title":"Current availability of model flags in PSID","text":"","category":"section"},{"location":"generic/#Active-Controller","page":"Industrial Renewable Models","title":"Active Controller","text":"","category":"section"},{"location":"generic/","page":"Industrial Renewable Models","title":"Industrial Renewable Models","text":"For the active controller, both Freq_Flag = 0 (ignoring frequency regulation) and Freq_Flag = 1 (considering frequency regulation) are available.","category":"page"},{"location":"generic/#Reactive-Controller","page":"Industrial Renewable Models","title":"Reactive Controller","text":"","category":"section"},{"location":"generic/","page":"Industrial Renewable Models","title":"Industrial Renewable Models","text":"The following table describes the current available combination of flags in PSID:","category":"page"},{"location":"generic/","page":"Industrial Renewable Models","title":"Industrial Renewable Models","text":"REF_Flag PF_Flag V_Flag Q_Flag\n0 0 0 0\n0 0 1 0\n1 0 1 1\n1 0 0 0","category":"page"},{"location":"generic/","page":"Industrial Renewable Models","title":"Industrial Renewable Models","text":"Any combination outside of these cases may not converge to a feasible operating point. Check the following CAISO report for the description and compliance of each flag combination.","category":"page"}] +} diff --git a/previews/PR360/siteinfo.js b/previews/PR360/siteinfo.js new file mode 100644 index 000000000..33d7c054f --- /dev/null +++ b/previews/PR360/siteinfo.js @@ -0,0 +1 @@ +var DOCUMENTER_CURRENT_VERSION = "previews/PR360"; diff --git a/previews/PR360/small/index.html b/previews/PR360/small/index.html new file mode 100644 index 000000000..f9e2b5b50 --- /dev/null +++ b/previews/PR360/small/index.html @@ -0,0 +1,32 @@ + +Small Signal · PowerSimulationsDynamics.jl

    Small Signal Analysis

    Here we discuss the method used to do a small signal analysis on the DAE system defined in PowerSimulationsDynamics.jl. The package defines algebraic variables for both real and imaginary voltages on all buses (except if they have a dynamic line connected, on which the voltage of those buses are treated as differential variables). In addition, each dynamic device can add differential variables (or states) that are concatenated to construct the system of differential algebraic equations.

    Note: The validation of small signal results is still work in progress due to the differences in the way that different software packages perform the calculations.

    Automatic Differentiation

    Once an equilibrium point is found, the complete jacobian of the non-linear system can be obtained using automatic differentiation in Julia. In particular, the package ForwardDiff.jl is used to obtain the jacobian of the non-linear algebraic system of equations. PowerSimulationsDynamics.jl handles the resulting jacobian and reports the reduced jacobian and the corresponding eigenvalues and eigenvectors.

    Jacobian Reduction

    We define $y$ as the vector of algebraic variables, $x$ as the vector of differential variables (states) and $p$ the parameters of the system, we can define $g(y,x,p)$ as the vector of algebraic equations and $f(y,x,p)$ as the vector of differential equations. With that, the non-linear differential algebraic system of equations can be written as:

    \[\begin{align} +\left[\begin{array}{c} + 0 \\ + \dot{x} + \end{array}\right] = \left[\begin{array}{c} + g(y,x,p) \\ + f(y,x,p) \end{array}\right] +\end{align}\]

    For small signal analysis, we are interested in the stability around an equilbrium point $y_{eq},x_{eq}$ that satisfies $\dot{x} = 0$ or equivalently $f(y_{eq},x_{eq},p) = 0$, while obviously satisfying $g(y_{eq}, x_{eq}, p) = 0$. To do that we use a first order approximation:

    \[\begin{align} +\left[\begin{array}{c} + 0 \\ + \Delta\dot{x} + \end{array}\right] = \underbrace{\left[\begin{array} + ~g(y_{eq},x_{eq},p) \\ + f(y_{eq},x_{eq},p) \end{array}\right]}_{ =~ 0} + + J[y_{eq}, x_{eq}, p] \left[\begin{array}{c} + \Delta y \\ + \Delta x + \end{array}\right] + \end{align}\]

    The first to note is that the jacobian matrix can be splitted in 4 blocks depending on the specific variables we are taking the partial derivatives:

    \[\begin{align} +J[y_{eq}, x_{eq}, p] = +\left[\begin{array}{cc} + g_y & g_x \\ + f_y & f_x \\ + \end{array}\right] +\end{align}\]

    For small signal analyses, we are interested in the stability of the differential states, while still considering that those need to evolve in the manifold defined by the linearized algebraic equations. Assuming that $g_y$ is not singular (see chapter 7 of Federico Milano's book: Power System Modelling and Scripting or the following paper) we can eliminate the algebraic variables to obtain the reduced jacobian:

    \[\begin{align} +J_{\text{red}} = f_x - f_y g_y^{-1} g_x +\end{align}\]

    that defines our reduced system for the differential variables

    \[\begin{align} +\Delta \dot{x} = J_{\text{red}} \Delta x +\end{align}\]

    on which we can compute its eigenvalues to analyze local stability.

    Accessing the Jacobian function

    You can retrieve the Jacobian function for a simulation using the get_jacobian function as follows:

    jacobian = function get_jacobian(ResidualModel, system)

    optionally you can pass the number of iterations to check for sparsity as follows:

    jacobian = function get_jacobian(ResidualModel, system, 0)

    if you specify 0, the jacobian function will use a full matrix.

    The return of get_jacobian is known as a functor in Julia and can be used to make evaluations. Currently, any function can be evaluated with the following inputs:

    jacobian(x)

    This version of the function is type unstable should only be used for non-critial ops. It works to get the eigenvalues given an operating point x

    jacobian(JM, x)

    This version evaluates in place the value of the jacobian for an operating point x and writes to the matrix JM

    jacobian(JM, x, p, t)

    This version complied with the requirements to be used in DiffEq for ODE solvers. p and t aren't used they just mean to match the interfaces. See DiffEqDocs

    jacobian(JM, dx, x, p, gamma, t)

    This version complied with the requirements to be used in DiffEq for DAE solvers. p and t aren't used they just mean to match the interfaces. It assumes that the jacobian has the form:

    \[\begin{align} + JM = \gamma * I + J(x) +\end{align}\]

    See DiffEqDocs for additional details.

    diff --git a/previews/PR360/tutorials/figs/14bus_gen_inv_speed.svg b/previews/PR360/tutorials/figs/14bus_gen_inv_speed.svg new file mode 100644 index 000000000..a16e6bb67 --- /dev/null +++ b/previews/PR360/tutorials/figs/14bus_gen_inv_speed.svg @@ -0,0 +1,52 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR360/tutorials/figs/14bus_gen_inv_volt.svg b/previews/PR360/tutorials/figs/14bus_gen_inv_volt.svg new file mode 100644 index 000000000..51ad669fe --- /dev/null +++ b/previews/PR360/tutorials/figs/14bus_gen_inv_volt.svg @@ -0,0 +1,72 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR360/tutorials/figs/14bus_gen_speed.svg b/previews/PR360/tutorials/figs/14bus_gen_speed.svg new file mode 100644 index 000000000..4959b0e43 --- /dev/null +++ b/previews/PR360/tutorials/figs/14bus_gen_speed.svg @@ -0,0 +1,52 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR360/tutorials/figs/14bus_gen_volt.svg b/previews/PR360/tutorials/figs/14bus_gen_volt.svg new file mode 100644 index 000000000..b7b4d655a --- /dev/null +++ b/previews/PR360/tutorials/figs/14bus_gen_volt.svg @@ -0,0 +1,72 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR360/tutorials/figs/omib_angle.svg b/previews/PR360/tutorials/figs/omib_angle.svg new file mode 100644 index 000000000..2a72e4c34 --- /dev/null +++ b/previews/PR360/tutorials/figs/omib_angle.svg @@ -0,0 +1,44 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR360/tutorials/figs/omib_volt.svg b/previews/PR360/tutorials/figs/omib_volt.svg new file mode 100644 index 000000000..98d49df6d --- /dev/null +++ b/previews/PR360/tutorials/figs/omib_volt.svg @@ -0,0 +1,44 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR360/tutorials/figs/plot_dynlines.svg b/previews/PR360/tutorials/figs/plot_dynlines.svg new file mode 100644 index 000000000..f1671bb14 --- /dev/null +++ b/previews/PR360/tutorials/figs/plot_dynlines.svg @@ -0,0 +1,48 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR360/tutorials/figs/plot_dynlines_zoom.svg b/previews/PR360/tutorials/figs/plot_dynlines_zoom.svg new file mode 100644 index 000000000..c7170f975 --- /dev/null +++ b/previews/PR360/tutorials/figs/plot_dynlines_zoom.svg @@ -0,0 +1,48 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR360/tutorials/figs/pv_curve_cpl.svg b/previews/PR360/tutorials/figs/pv_curve_cpl.svg new file mode 100644 index 000000000..ed990d89c --- /dev/null +++ b/previews/PR360/tutorials/figs/pv_curve_cpl.svg @@ -0,0 +1,44 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR360/tutorials/figs/pv_curve_cpl_genrou.svg b/previews/PR360/tutorials/figs/pv_curve_cpl_genrou.svg new file mode 100644 index 000000000..ce357d7b3 --- /dev/null +++ b/previews/PR360/tutorials/figs/pv_curve_cpl_genrou.svg @@ -0,0 +1,214 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR360/tutorials/figs/v1101_comparison.svg b/previews/PR360/tutorials/figs/v1101_comparison.svg new file mode 100644 index 000000000..cadeaf166 --- /dev/null +++ b/previews/PR360/tutorials/figs/v1101_comparison.svg @@ -0,0 +1,48 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR360/tutorials/figs/v1101_ida.svg b/previews/PR360/tutorials/figs/v1101_ida.svg new file mode 100644 index 000000000..a1ec216cc --- /dev/null +++ b/previews/PR360/tutorials/figs/v1101_ida.svg @@ -0,0 +1,50 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/previews/PR360/tutorials/modified_sys.json b/previews/PR360/tutorials/modified_sys.json new file mode 100644 index 000000000..a86cb1590 --- /dev/null +++ b/previews/PR360/tutorials/modified_sys.json @@ -0,0 +1 @@ +{"internal":{"uuid":{"value":"ca00e541-0c03-4b27-a87f-4ee0c63a03b0"},"ext":{},"units_info":null},"data":{"time_series_in_memory":false,"masked_components":[],"version_info":{"julia_version":"1.10.0","package_info":"Status `~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/docs/Manifest.toml`\n [47edcb42] ADTypes v0.2.6\n [a4c015fc] ANSIColoredPrinters v0.0.1\n [1520ce14] AbstractTrees v0.4.4\n⌅ [79e6a3ab] Adapt v3.7.2\n [ec485272] ArnoldiMethod v0.2.0\n [4fba245c] ArrayInterface v7.7.0\n [4c555306] ArrayLayouts v1.4.5\n [d1d4a3ce] BitFlags v0.1.8\n [62783981] BitTwiddlingConvenienceFunctions v0.1.5\n [a74b3585] Blosc v0.7.3\n [fa961155] CEnum v0.5.0\n [2a0fbf3d] CPUSummary v0.2.4\n [336ed68f] CSV v0.10.12\n [fb6a15b2] CloseOpenIntervals v0.1.12\n [944b1d66] CodecZlib v0.7.3\n [35d6a980] ColorSchemes v3.24.0\n [3da002f7] ColorTypes v0.11.4\n [c3611d14] ColorVectorSpace v0.10.0\n [5ae59095] Colors v0.12.10\n [38540f10] CommonSolve v0.2.4\n [bbf7d656] CommonSubexpressions v0.3.0\n [34da2185] Compat v4.10.1\n [2569d6c7] ConcreteStructs v0.2.3\n [f0e56b4a] ConcurrentUtilities v2.3.0\n [187b0558] ConstructionBase v1.5.4\n [d38c429a] Contour v0.6.2\n [adafc99b] CpuId v0.3.1\n [a8cc5b0e] Crayons v4.1.1\n [9a962f9c] DataAPI v1.15.0\n [a93c6f00] DataFrames v1.6.1\n [864edb3b] DataStructures v0.18.16\n [e2d170a0] DataValueInterfaces v1.0.0\n [8bb1440f] DelimitedFiles v1.9.1\n [2b5f629d] DiffEqBase v6.145.6\n [163ba53b] DiffResults v1.1.0\n [b552c78f] DiffRules v1.15.1\n [b4f34e82] Distances v0.10.11\n [ffbed154] DocStringExtensions v0.9.3\n⌅ [e30172f5] Documenter v0.27.25\n [35a29f4d] DocumenterTools v0.1.18\n [4e289a0a] EnumX v1.0.4\n [f151be2c] EnzymeCore v0.6.5\n [460bff9d] ExceptionUnwrapping v0.1.10\n [d4d017d3] ExponentialUtilities v1.25.0\n [e2ba6199] ExprTools v0.1.10\n [c87230d0] FFMPEG v0.4.1\n [7034ab61] FastBroadcast v0.2.8\n [9aa1b823] FastClosures v0.3.2\n [29a986be] FastLapackInterface v2.0.0\n [48062228] FilePathsBase v0.9.21\n [1a297f60] FillArrays v1.9.3\n [6a86dc24] FiniteDiff v2.22.0\n [53c48c17] FixedPointNumbers v0.8.4\n [59287772] Formatting v0.4.2\n [f6369f11] ForwardDiff v0.10.36\n [069b7b12] FunctionWrappers v1.1.3\n [77dc65aa] FunctionWrappersWrappers v0.1.3\n⌃ [46192b85] GPUArraysCore v0.1.5\n⌅ [28b8d3ca] GR v0.72.10\n [c145ed77] GenericSchur v0.5.3\n [86223c79] Graphs v1.9.0\n [42e2da0e] Grisu v1.0.2\n [708ec375] Gumbo v0.8.2\n [c8ec2601] H5Zblosc v0.1.2\n [f67ccb44] HDF5 v0.17.1\n [cd3eb016] HTTP v1.10.1\n [3e5b6fbb] HostCPUFeatures v0.1.16\n [b5f81e59] IOCapture v0.2.3\n [615f187c] IfElse v0.1.1\n [d25df0c9] Inflate v0.1.4\n [2cd47ed4] InfrastructureSystems v1.22.1\n [842dd82b] InlineStrings v1.4.0\n [41ab1584] InvertedIndices v1.3.0\n [92d709cd] IrrationalConstants v0.2.2\n [82899510] IteratorInterfaceExtensions v1.0.0\n [1019f520] JLFzf v0.1.7\n [692b3bcd] JLLWrappers v1.5.0\n [682c06a0] JSON v0.21.4\n [0f8b85d8] JSON3 v1.14.0\n [ef3ab10e] KLU v0.4.1\n [ba0b0d4f] Krylov v0.9.5\n [b964fa9f] LaTeXStrings v1.3.1\n [23fbe1c1] Latexify v0.16.1\n [10f19ff3] LayoutPointers v0.1.15\n [50d2b5c4] Lazy v0.15.1\n [5078a376] LazyArrays v1.8.3\n [1d6d02ad] LeftChildRightSiblingTrees v0.2.0\n [d3d80556] LineSearches v7.2.0\n [7ed4a6bd] LinearSolve v2.22.0\n [2ab3a3ac] LogExpFunctions v0.3.26\n [e6f89c97] LoggingExtras v1.0.3\n [bdcacae8] LoopVectorization v0.12.166\n [33e6dc65] MKL v0.6.2\n [3da0fdf6] MPIPreferences v0.1.10\n [1914dd2f] MacroTools v0.5.12\n [d125e4d3] ManualMemory v0.1.8\n [299715c1] MarchingCubes v0.1.9\n [a3b82374] MatrixFactorizations v2.1.0\n [bb5d69b7] MaybeInplace v0.1.1\n [739be429] MbedTLS v1.1.9\n [442fdcdd] Measures v0.3.2\n [e1d29d7a] Missings v1.1.0\n [46d2c3a1] MuladdMacro v0.2.4\n [ffc61752] Mustache v1.0.19\n [d41bc354] NLSolversBase v7.8.3\n [2774e3e8] NLsolve v4.5.1\n [77ba4419] NaNMath v1.0.2\n [8913a72c] NonlinearSolve v3.4.0\n [6fe1bfb0] OffsetArrays v1.13.0\n [4d8831e6] OpenSSL v1.4.1\n [bac558e1] OrderedCollections v1.6.3\n [1dea7af3] OrdinaryDiffEq v6.68.0\n [65ce6f38] PackageExtensionCompat v1.0.2\n [d96e819e] Parameters v0.12.3\n [46dd5b70] Pardiso v0.5.4\n [69de0a69] Parsers v2.8.1\n [b98c9c47] Pipe v1.3.0\n [ccf2f8ad] PlotThemes v3.1.0\n [995b91a9] PlotUtils v1.4.0\n [91a5bcdd] Plots v1.39.0\n [f517fe37] Polyester v0.7.9\n [1d0040c9] PolyesterWeave v0.2.1\n [2dfb63ee] PooledArrays v1.4.3\n [dd99e9e3] PowerFlowData v1.5.0\n [94fada2c] PowerFlows v0.6.1\n [bed98974] PowerNetworkMatrices v0.9.6\n [398b2ede] PowerSimulationsDynamics v0.13.0 `~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl`\n [f00506e0] PowerSystemCaseBuilder v1.2.2\n [bcd98974] PowerSystems v3.2.0\n [d236fae5] PreallocationTools v0.4.17\n [aea7be01] PrecompileTools v1.2.0\n [21216c6a] Preferences v1.4.1\n [08abe8d2] PrettyTables v2.3.1\n [33c8b6b6] ProgressLogging v0.1.4\n [3cdcf5f2] RecipesBase v1.3.4\n [01d81517] RecipesPipeline v0.6.12\n [731186ca] RecursiveArrayTools v3.4.0\n [f2c3362d] RecursiveFactorization v0.2.21\n [189a3867] Reexport v1.2.2\n [05181044] RelocatableFolders v1.0.1\n [ae029012] Requires v1.3.0\n [7e49a35a] RuntimeGeneratedFunctions v0.5.12\n [94e857df] SIMDTypes v0.1.0\n [476501e8] SLEEFPirates v0.6.42\n [322a6be2] Sass v0.2.0\n [0bca4576] SciMLBase v2.16.3\n [c0aeaf25] SciMLOperators v0.3.7\n [6c6a2e73] Scratch v1.2.1\n [91c51154] SentinelArrays v1.4.1\n [efcf1570] Setfield v1.1.1\n [992d4aef] Showoff v1.0.3\n [777ac1f9] SimpleBufferStream v1.1.0\n [727e6d20] SimpleNonlinearSolve v1.2.0\n [699a6c99] SimpleTraits v0.9.4\n [ce78b400] SimpleUnPack v1.1.0\n [a2af1166] SortingAlgorithms v1.2.1\n [47a9eef4] SparseDiffTools v2.15.0\n [e56a9233] Sparspak v0.3.9\n [276daf66] SpecialFunctions v2.3.1\n [aedffcd0] Static v0.8.8\n [0d7ed370] StaticArrayInterface v1.5.0\n [90137ffa] StaticArrays v1.9.0\n [1e83bf80] StaticArraysCore v1.4.2\n [82ae8749] StatsAPI v1.7.0\n [2913bbd2] StatsBase v0.34.2\n [7792a7ef] StrideArraysCore v0.5.2\n [69024149] StringEncodings v0.3.7\n [892a3eda] StringManipulation v0.3.4\n [856f2bd8] StructTypes v1.10.0\n [c3572dad] Sundials v4.23.1\n [2efcf032] SymbolicIndexingInterface v0.3.3\n [3783bdb8] TableTraits v1.0.1\n [bd369af6] Tables v1.11.1\n [62fd8b95] TensorCore v0.1.1\n [5d786b92] TerminalLoggers v0.1.7\n [8290d209] ThreadingUtilities v0.5.2\n⌅ [9e3dc215] TimeSeries v0.23.2\n [a759f4b9] TimerOutputs v0.5.23\n [3bb67fe8] TranscodingStreams v0.10.2\n [d5829a12] TriangularSolve v0.1.20\n [410a4b4d] Tricks v0.1.8\n [781d530d] TruncatedStacktraces v1.4.0\n [5c2747f8] URIs v1.5.1\n [3a884ed6] UnPack v1.0.2\n [1cfade01] UnicodeFun v0.4.1\n [b8865327] UnicodePlots v3.6.3\n [1986cc42] Unitful v1.19.0\n [45397f5d] UnitfulLatexify v1.6.3\n [41fe7b60] Unzip v0.2.0\n [3d5dd08c] VectorizationBase v0.21.65\n [19fa3120] VertexSafeGraphs v0.2.0\n [ea10d353] WeakRefStrings v1.4.2\n [76eceee3] WorkerUtilities v1.6.1\n [ddb6d928] YAML v0.4.9\n [0b7ba130] Blosc_jll v1.21.5+0\n [6e34b625] Bzip2_jll v1.0.8+0\n [83423d85] Cairo_jll v1.16.1+1\n [2702e6a9] EpollShim_jll v0.0.20230411+0\n [2e619515] Expat_jll v2.5.0+0\n⌃ [b22a6f82] FFMPEG_jll v4.4.2+2\n [a3f928ae] Fontconfig_jll v2.13.93+0\n [d7e528f0] FreeType2_jll v2.13.1+0\n [559328eb] FriBidi_jll v1.0.10+0\n [0656b61e] GLFW_jll v3.3.9+0\n⌅ [d2c73de3] GR_jll v0.72.10+0\n [78b55507] Gettext_jll v0.21.0+0\n [7746bdde] Glib_jll v2.76.5+0\n [3b182d85] Graphite2_jll v1.3.14+0\n [528830af] Gumbo_jll v0.10.2+0\n⌃ [0234f1f7] HDF5_jll v1.12.2+2\n [2e76f6c2] HarfBuzz_jll v2.8.1+1\n⌅ [1d5cc7b8] IntelOpenMP_jll v2023.2.0+0\n [aacddb02] JpegTurbo_jll v3.0.1+0\n [c1c5ebd0] LAME_jll v3.100.1+0\n [88015f11] LERC_jll v3.0.0+1\n [1d63c593] LLVMOpenMP_jll v15.0.7+0\n [dd4b983a] LZO_jll v2.10.1+0\n⌅ [e9f186c6] Libffi_jll v3.2.2+1\n [d4300ac3] Libgcrypt_jll v1.8.7+0\n [7e76a0d4] Libglvnd_jll v1.6.0+0\n [7add5ba3] Libgpg_error_jll v1.42.0+0\n [94ce4f54] Libiconv_jll v1.17.0+0\n [4b2f31a3] Libmount_jll v2.35.0+0\n⌅ [89763e89] Libtiff_jll v4.5.1+1\n [38a345b3] Libuuid_jll v2.36.0+0\n [5ced341a] Lz4_jll v1.9.4+0\n⌅ [856f044c] MKL_jll v2022.2.0+0\n [e7412a2a] Ogg_jll v1.3.5+1\n⌅ [9bd350c2] OpenSSH_jll v8.9.0+1\n⌅ [458c3c95] OpenSSL_jll v1.1.23+0\n [efe28fd5] OpenSpecFun_jll v0.5.5+0\n [91d4177d] Opus_jll v1.3.2+0\n [30392449] Pixman_jll v0.42.2+0\n⌃ [c0090381] Qt6Base_jll v6.5.2+2\n⌅ [fb77eaff] Sundials_jll v5.2.2+0\n [a44049a8] Vulkan_Loader_jll v1.3.243+0\n [a2964d1f] Wayland_jll v1.21.0+1\n [2381bf8a] Wayland_protocols_jll v1.31.0+0\n [02c8fc9c] XML2_jll v2.12.2+0\n [aed1982a] XSLT_jll v1.1.34+0\n [ffd25f8a] XZ_jll v5.4.5+0\n [f67eecfb] Xorg_libICE_jll v1.0.10+1\n [c834827a] Xorg_libSM_jll v1.2.3+0\n [4f6342f7] Xorg_libX11_jll v1.8.6+0\n [0c0b7dd1] Xorg_libXau_jll v1.0.11+0\n [935fb764] Xorg_libXcursor_jll v1.2.0+4\n [a3789734] Xorg_libXdmcp_jll v1.1.4+0\n [1082639a] Xorg_libXext_jll v1.3.4+4\n [d091e8ba] Xorg_libXfixes_jll v5.0.3+4\n [a51aa0fd] Xorg_libXi_jll v1.7.10+4\n [d1454406] Xorg_libXinerama_jll v1.1.4+4\n [ec84b674] Xorg_libXrandr_jll v1.5.2+4\n [ea2f1a96] Xorg_libXrender_jll v0.9.10+4\n [14d82f49] Xorg_libpthread_stubs_jll v0.1.1+0\n [c7cfdc94] Xorg_libxcb_jll v1.15.0+0\n [cc61e674] Xorg_libxkbfile_jll v1.1.2+0\n [e920d4aa] Xorg_xcb_util_cursor_jll v0.1.4+0\n [12413925] Xorg_xcb_util_image_jll v0.4.0+1\n [2def613f] Xorg_xcb_util_jll v0.4.0+1\n [975044d2] Xorg_xcb_util_keysyms_jll v0.4.0+1\n [0d47668e] Xorg_xcb_util_renderutil_jll v0.3.9+1\n [c22f9ab0] Xorg_xcb_util_wm_jll v0.4.1+1\n [35661453] Xorg_xkbcomp_jll v1.4.6+0\n [33bec58e] Xorg_xkeyboard_config_jll v2.39.0+0\n [c5fb5394] Xorg_xtrans_jll v1.5.0+0\n [3161d3a3] Zstd_jll v1.5.5+0\n [35ca27e7] eudev_jll v3.2.9+0\n [214eeab7] fzf_jll v0.43.0+0\n [1a1c6b14] gperf_jll v3.1.1+0\n [a4ae2306] libaom_jll v3.4.0+0\n [0ac62f75] libass_jll v0.15.1+0\n [2db6ffa8] libevdev_jll v1.11.0+0\n [f638f0a6] libfdk_aac_jll v2.0.2+0\n [36db933b] libinput_jll v1.18.0+0\n [b53b4c65] libpng_jll v1.6.40+0\n [47bcb7c8] libsass_jll v3.6.4+0\n [f27f6e37] libvorbis_jll v1.3.7+1\n [009596ad] mtdev_jll v1.1.6+0\n [1270edf5] x264_jll v2021.5.5+0\n [dfaa095f] x265_jll v3.5.0+0\n [d8fb68d0] xkbcommon_jll v1.4.1+1\n [0dad84c5] ArgTools v1.1.1\n [56f22d72] Artifacts\n [2a0f44e3] Base64\n [ade2ca70] Dates\n [8ba89e20] Distributed\n [f43a241f] Downloads v1.6.0\n [7b1f6079] FileWatching\n [9fa8497b] Future\n [b77e0a4c] InteractiveUtils\n [4af54fe1] LazyArtifacts\n [b27032c2] LibCURL v0.6.4\n [76f85450] LibGit2\n [8f399da3] Libdl\n [37e2e46d] LinearAlgebra\n [56ddb016] Logging\n [d6f4376e] Markdown\n [a63ad114] Mmap\n [ca575930] NetworkOptions v1.2.0\n [44cfe95a] Pkg v1.10.0\n [de0858da] Printf\n [3fa0cd96] REPL\n [9a3f8284] Random\n [ea8e919c] SHA v0.7.0\n [9e88b42a] Serialization\n [1a1011a3] SharedArrays\n [6462fe0b] Sockets\n [2f01184e] SparseArrays v1.10.0\n [10745b16] Statistics v1.10.0\n [4607b0f0] SuiteSparse\n [fa267f1f] TOML v1.0.3\n [a4e569a6] Tar v1.10.0\n [8dfed614] Test\n [cf7118a7] UUIDs\n [4ec0a83e] Unicode\n [e66e0078] CompilerSupportLibraries_jll v1.0.5+1\n [deac9b47] LibCURL_jll v8.4.0+0\n [e37daf67] LibGit2_jll v1.6.4+0\n [29816b5a] LibSSH2_jll v1.11.0+1\n [c8ffd9c3] MbedTLS_jll v2.28.2+1\n [14a3606d] MozillaCACerts_jll v2023.1.10\n [4536629a] OpenBLAS_jll v0.3.23+2\n [05823500] OpenLibm_jll v0.8.1+2\n [efcefdf7] PCRE2_jll v10.42.0+1\n [bea87d4a] SuiteSparse_jll v7.2.1+1\n [83775a58] Zlib_jll v1.2.13+1\n [8e850b90] libblastrampoline_jll v5.8.0+1\n [8e850ede] nghttp2_jll v1.52.0+1\n [3f19e933] p7zip_jll v17.4.0+2\nInfo 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`\n"},"internal":{"uuid":{"value":"775e8f25-c0d2-4a59-9f03-0393b3065829"},"ext":{},"units_info":null},"time_series_compression_enabled":false,"components":[{"base_power":100.0,"services":[],"bus":{"value":"6185e308-980c-430a-ab02-cb3ef9eaaba2"},"max_constant_active_power":0.5,"available":true,"time_series_container":[],"name":"load1011","max_current_active_power":0.0,"constant_active_power":0.5,"dynamic_injector":null,"__metadata__":{"module":"PowerSystems","type":"StandardLoad"},"current_active_power":0.0,"current_reactive_power":0.0,"internal":{"uuid":{"value":"c5fa5e2b-2c4d-49e8-8340-4b3dbc9cfd28"},"ext":null,"units_info":null},"ext":{},"max_constant_reactive_power":0.1,"max_current_reactive_power":0.0,"impedance_reactive_power":0.0,"impedance_active_power":0.0,"max_impedance_active_power":0.0,"constant_reactive_power":0.1,"max_impedance_reactive_power":0.0},{"base_power":100.0,"services":[],"bus":{"value":"c7104604-7a96-4c09-8194-7c70bc5a1045"},"max_constant_active_power":0.3,"available":true,"time_series_container":[],"name":"load1031","max_current_active_power":0.0,"constant_active_power":0.3,"dynamic_injector":null,"__metadata__":{"module":"PowerSystems","type":"StandardLoad"},"current_active_power":0.0,"current_reactive_power":0.0,"internal":{"uuid":{"value":"4428fd3d-6dcc-445e-ba24-af7f0b38d654"},"ext":null,"units_info":null},"ext":{},"max_constant_reactive_power":0.1,"max_current_reactive_power":0.0,"impedance_reactive_power":0.0,"impedance_active_power":0.0,"max_impedance_active_power":0.0,"constant_reactive_power":0.1,"max_impedance_reactive_power":0.0},{"base_power":100.0,"services":[],"bus":{"value":"ef00fc34-5c7b-4a19-aef6-fd07b57c9d83"},"max_constant_active_power":1.0,"available":true,"time_series_container":[],"name":"load1021","max_current_active_power":0.0,"constant_active_power":1.0,"dynamic_injector":null,"__metadata__":{"module":"PowerSystems","type":"StandardLoad"},"current_active_power":0.0,"current_reactive_power":0.0,"internal":{"uuid":{"value":"153821cb-5560-44e2-aa56-123ffb31a52a"},"ext":null,"units_info":null},"ext":{},"max_constant_reactive_power":0.3,"max_current_reactive_power":0.0,"impedance_reactive_power":0.0,"impedance_active_power":0.0,"max_impedance_active_power":0.0,"constant_reactive_power":0.3,"max_impedance_reactive_power":0.0},{"internal_voltage":1.0,"services":[],"bus":{"value":"6185e308-980c-430a-ab02-cb3ef9eaaba2"},"available":true,"name":"InfBus","internal_angle":0.0,"active_power":0.0,"dynamic_injector":null,"__metadata__":{"module":"PowerSystems","type":"Source"},"internal":{"uuid":{"value":"9e890094-4b1a-4320-93b6-d667a31082a7"},"ext":null,"units_info":null},"ext":{},"X_th":5.0e-6,"R_th":0.0,"reactive_power":0.0},{"base_power":100.0,"prime_mover_type":"OT","rating":3.333526661060325,"services":[],"bus":{"value":"ef00fc34-5c7b-4a19-aef6-fd07b57c9d83"},"available":true,"time_series_container":[],"name":"generator-102-1","status":true,"active_power":0.7,"dynamic_injector":{"value":"5b47b848-fb0a-4b07-a55e-a39217f6dd71"},"__metadata__":{"module":"PowerSystems","type":"ThermalStandard"},"fuel":"OTHER","internal":{"uuid":{"value":"5b3f8cab-47a8-450e-b9bc-ebc859eabc94"},"ext":null,"units_info":null},"reactive_power_limits":{"min":-1.0,"max":1.0},"ext":{"z_source":{"r":0.0,"x":1.0}},"operation_cost":{"start_up":0.0,"fixed":0.0,"shut_down":0.0,"variable":{"cost":[0.0,1.0]},"__metadata__":{"module":"PowerSystems","type":"ThreePartCost"}},"time_limits":null,"must_run":false,"ramp_limits":{"up":3.18,"down":3.18},"time_at_status":10000.0,"active_power_limits":{"min":0.0,"max":3.18},"reactive_power":0.0},{"base_power":100.0,"prime_mover_type":"OT","rating":3.333526661060325,"services":[],"bus":{"value":"c7104604-7a96-4c09-8194-7c70bc5a1045"},"available":true,"time_series_container":[],"name":"generator-103-1","status":true,"active_power":0.8,"dynamic_injector":null,"__metadata__":{"module":"PowerSystems","type":"ThermalStandard"},"fuel":"OTHER","internal":{"uuid":{"value":"40c4ca40-50b0-4c2e-b113-aaf2c79ba3e4"},"ext":null,"units_info":null},"reactive_power_limits":{"min":-1.0,"max":1.0},"ext":{"z_source":{"r":0.0,"x":1.0}},"operation_cost":{"start_up":0.0,"fixed":0.0,"shut_down":0.0,"variable":{"cost":[0.0,1.0]},"__metadata__":{"module":"PowerSystems","type":"ThreePartCost"}},"time_limits":null,"must_run":false,"ramp_limits":{"up":3.18,"down":3.18},"time_at_status":10000.0,"active_power_limits":{"min":0.0,"max":3.18},"reactive_power":0.0},{"base_power":100.0,"shaft":{"internal":{"uuid":{"value":"b38ea386-1a07-45cf-8f58-af9830b88203"},"ext":null,"units_info":null},"n_states":2,"ext":{},"D":2.0,"states":["δ","ω"],"H":3.148,"__metadata__":{"module":"PowerSystems","type":"SingleMass"}},"states":["δ","ω"],"name":"generator-102-1","n_states":2,"ω_ref":1.0,"__metadata__":{"parameters":["BaseMachine","SingleMass","AVRFixed","TGFixed","PSSFixed"],"module":"PowerSystems","type":"DynamicGenerator"},"avr":{"states_types":[],"internal":{"uuid":{"value":"8dc72473-ef58-4f56-8825-8f565db8e992"},"ext":null,"units_info":null},"n_states":0,"ext":{},"V_ref":1.0,"states":[],"Vf":0.0,"__metadata__":{"module":"PowerSystems","type":"AVRFixed"}},"internal":{"uuid":{"value":"5b47b848-fb0a-4b07-a55e-a39217f6dd71"},"ext":null,"units_info":null},"ext":{},"machine":{"internal":{"uuid":{"value":"d32afdf3-76c3-4a7e-83c9-b34af1ef223a"},"ext":null,"units_info":null},"n_states":0,"ext":{},"Xd_p":0.2995,"eq_p":0.7087,"R":0.0,"states":[],"__metadata__":{"module":"PowerSystems","type":"BaseMachine"}},"pss":{"V_pss":0.0,"internal":{"uuid":{"value":"8e8a5698-6218-4e7d-aee4-5c566308ce74"},"ext":null,"units_info":null},"n_states":0,"ext":{},"states":[],"__metadata__":{"module":"PowerSystems","type":"PSSFixed"}},"prime_mover":{"P_ref":1.0,"internal":{"uuid":{"value":"e3c11fa9-7561-4729-9c82-75bfb5ae50ee"},"ext":null,"units_info":null},"efficiency":1.0,"n_states":0,"ext":{},"states":[],"__metadata__":{"module":"PowerSystems","type":"TGFixed"}}},{"internal":{"uuid":{"value":"0d1bd811-bbc8-4e4d-bf13-ed12d6ef5c7a"},"ext":null,"units_info":null},"to":{"value":"c7104604-7a96-4c09-8194-7c70bc5a1045"},"from":{"value":"6185e308-980c-430a-ab02-cb3ef9eaaba2"},"__metadata__":{"module":"PowerSystems","type":"Arc"}},{"internal":{"uuid":{"value":"e3c27795-5eba-4e3a-b6b0-7fc9d23d3cc5"},"ext":null,"units_info":null},"to":{"value":"ef00fc34-5c7b-4a19-aef6-fd07b57c9d83"},"from":{"value":"6185e308-980c-430a-ab02-cb3ef9eaaba2"},"__metadata__":{"module":"PowerSystems","type":"Arc"}},{"internal":{"uuid":{"value":"a0998501-8726-491f-a22f-8455f85585de"},"ext":null,"units_info":null},"to":{"value":"c7104604-7a96-4c09-8194-7c70bc5a1045"},"from":{"value":"ef00fc34-5c7b-4a19-aef6-fd07b57c9d83"},"__metadata__":{"module":"PowerSystems","type":"Arc"}},{"number":103,"base_voltage":138.0,"bustype":"PV","angle":0.0,"name":"BUS 3","magnitude":1.0059,"__metadata__":{"module":"PowerSystems","type":"ACBus"},"internal":{"uuid":{"value":"c7104604-7a96-4c09-8194-7c70bc5a1045"},"ext":null,"units_info":null},"area":{"value":"4310e555-c5ec-48ff-b7ed-faf99cb4cdd5"},"ext":{},"voltage_limits":{"min":0.9,"max":1.1},"load_zone":{"value":"c3b01007-c199-4a4d-b38b-1e9d55312556"}},{"number":101,"base_voltage":138.0,"bustype":"REF","angle":0.0,"name":"BUS 1","magnitude":1.02,"__metadata__":{"module":"PowerSystems","type":"ACBus"},"internal":{"uuid":{"value":"6185e308-980c-430a-ab02-cb3ef9eaaba2"},"ext":null,"units_info":null},"area":{"value":"4310e555-c5ec-48ff-b7ed-faf99cb4cdd5"},"ext":{},"voltage_limits":{"min":0.9,"max":1.1},"load_zone":{"value":"c3b01007-c199-4a4d-b38b-1e9d55312556"}},{"number":102,"base_voltage":138.0,"bustype":"PV","angle":0.0,"name":"BUS 2","magnitude":1.0142,"__metadata__":{"module":"PowerSystems","type":"ACBus"},"internal":{"uuid":{"value":"ef00fc34-5c7b-4a19-aef6-fd07b57c9d83"},"ext":null,"units_info":null},"area":{"value":"4310e555-c5ec-48ff-b7ed-faf99cb4cdd5"},"ext":{},"voltage_limits":{"min":0.9,"max":1.1},"load_zone":{"value":"c3b01007-c199-4a4d-b38b-1e9d55312556"}},{"__metadata__":{"module":"PowerSystems","type":"LoadZone"},"name":"1","internal":{"uuid":{"value":"c3b01007-c199-4a4d-b38b-1e9d55312556"},"ext":null,"units_info":null},"peak_active_power":1.8,"peak_reactive_power":0.5,"time_series_container":[]},{"services":[],"x":0.12,"b":{"from":0.1,"to":0.1},"r":0.01,"rate":2.5,"available":true,"time_series_container":[],"name":"BUS 1-BUS 3-i_1","reactive_power_flow":0.0,"arc":{"value":"0d1bd811-bbc8-4e4d-bf13-ed12d6ef5c7a"},"__metadata__":{"module":"PowerSystems","type":"Line"},"internal":{"uuid":{"value":"2f0cf6ea-3179-4c8c-aa54-be94375ea015"},"ext":null,"units_info":null},"ext":{},"active_power_flow":0.0,"angle_limits":{"min":-1.0472,"max":1.0472}},{"services":[],"x":0.12,"b":{"from":0.1,"to":0.1},"r":0.01,"rate":2.5,"available":true,"time_series_container":[],"name":"BUS 1-BUS 2-i_1","reactive_power_flow":0.0,"arc":{"value":"e3c27795-5eba-4e3a-b6b0-7fc9d23d3cc5"},"__metadata__":{"module":"PowerSystems","type":"Line"},"internal":{"uuid":{"value":"5cd1464f-c657-4ad5-ab13-ce6ef045922d"},"ext":null,"units_info":null},"ext":{},"active_power_flow":0.0,"angle_limits":{"min":-1.0472,"max":1.0472}},{"services":[],"x":0.9,"b":{"from":0.5,"to":0.5},"r":0.02,"rate":2.5,"available":true,"time_series_container":[],"name":"BUS 2-BUS 3-i_1","reactive_power_flow":0.0,"arc":{"value":"a0998501-8726-491f-a22f-8455f85585de"},"__metadata__":{"module":"PowerSystems","type":"Line"},"internal":{"uuid":{"value":"7451b53e-c5aa-4f3f-bffc-3033c9b86ca8"},"ext":null,"units_info":null},"ext":{},"active_power_flow":0.0,"angle_limits":{"min":-1.0472,"max":1.0472}},{"load_response":0.0,"name":"1","__metadata__":{"module":"PowerSystems","type":"Area"},"internal":{"uuid":{"value":"4310e555-c5ec-48ff-b7ed-faf99cb4cdd5"},"ext":null,"units_info":null},"peak_active_power":0.0,"peak_reactive_power":0.0,"time_series_container":[]}],"validation_descriptor_file":"modified_sys_validation_descriptors.json","time_series_params":{"__metadata__":{"module":"InfrastructureSystems","type":"TimeSeriesParameters"},"resolution":{"value":0,"type":"Minute"},"forecast_params":{"initial_timestamp":"0001-01-01T00:00:00.0","interval":{"value":0,"type":"Minute"},"horizon":0,"count":0,"__metadata__":{"module":"InfrastructureSystems","type":"ForecastParameters"}}}},"units_settings":{"base_value":100.0,"unit_system":"SYSTEM_BASE"},"frequency":60.0,"runchecks":true,"metadata":{"name":null,"description":null,"__metadata__":{"module":"PowerSystems","type":"SystemMetadata"}},"data_format_version":"3.0.0"} \ No newline at end of file diff --git a/previews/PR360/tutorials/modified_sys_metadata.json b/previews/PR360/tutorials/modified_sys_metadata.json new file mode 100644 index 000000000..edfb83aaf --- /dev/null +++ b/previews/PR360/tutorials/modified_sys_metadata.json @@ -0,0 +1,46 @@ +{ + "name": "", + "description": "", + "frequency": 60, + "time_series_resolution_milliseconds": 0, + "component_counts": [ + { + "type": "ACBus", + "count": 3 + }, + { + "type": "Arc", + "count": 3 + }, + { + "type": "Area", + "count": 1 + }, + { + "type": "DynamicGenerator", + "count": 1 + }, + { + "type": "Line", + "count": 3 + }, + { + "type": "LoadZone", + "count": 1 + }, + { + "type": "Source", + "count": 1 + }, + { + "type": "StandardLoad", + "count": 3 + }, + { + "type": "ThermalStandard", + "count": 2 + } + ], + "time_series_counts": [ + ] +} \ No newline at end of file diff --git a/previews/PR360/tutorials/modified_sys_validation_descriptors.json b/previews/PR360/tutorials/modified_sys_validation_descriptors.json new file mode 100644 index 000000000..ba401f09a --- /dev/null +++ b/previews/PR360/tutorials/modified_sys_validation_descriptors.json @@ -0,0 +1 @@ +{"struct_validation_descriptors":[{"fields":[{"name":"variable","data_type":"VariableCost","null_value":"VariableCost((0.0, 0.0))","comment":"variable cost"},{"name":"fixed","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"fixed cost","valid_range":{"max":null,"min":0}}],"docstring":"Data Structure Operational Cost Data in two parts: fixed and variable cost.","struct_name":"TwoPartCost","supertype":"OperationalCost"},{"fields":[{"name":"variable","data_type":"VariableCost","null_value":"VariableCost((0.0, 0.0))","comment":"variable cost"},{"name":"fixed","data_type":"Float64","null_value":"0.0","comment":"fixed cost"},{"name":"start_up","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"start-up cost","valid_range":{"max":null,"min":0}},{"name":"shut_down","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"shut-down cost","valid_range":{"max":null,"min":0}}],"docstring":"Data Structure Operational Cost Data in Three parts fixed, variable cost and start - stop costs.","struct_name":"ThreePartCost","supertype":"OperationalCost"},{"fields":[{"name":"variable","default":"VariableCost((0.0, 0.0))","data_type":"VariableCost","null_value":"VariableCost((0.0, 0.0))","comment":"variable cost"},{"name":"fixed","default":"0.0","data_type":"Float64","null_value":"0.0","comment":"fixed cost"},{"name":"start_up","default":"0.0","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"start-up cost","valid_range":{"max":null,"min":0}},{"name":"shut_down","default":"0.0","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"shut-down cost","valid_range":{"max":null,"min":0}},{"name":"energy_shortage_cost","default":"0.0","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Cost incurred by the model for being short of the energy target.","valid_range":{"max":null,"min":0}},{"name":"energy_surplus_cost","default":"0.0","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Cost incurred by the model for surplus energy stored.","valid_range":{"max":null,"min":0}}],"docstring":"Data Structure for Operational Cost Data like variable cost and start - stop costs and energy storage cost.","struct_name":"StorageManagementCost","supertype":"OperationalCost"},{"fields":[{"name":"no_load","data_type":"Float64","null_value":"0.0","comment":"no load cost"},{"name":"start_up","data_type":"NamedTuple{(:hot, :warm, :cold), NTuple{3, Float64}}","null_value":"(hot = START_COST, warm = START_COST, cold = START_COST)","comment":"start-up cost at different stages of the thermal cycle. Warm is also refered as intermediate in some markets"},{"name":"shut_down","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"shut-down cost","valid_range":{"max":null,"min":0}},{"name":"variable","default":"nothing","data_type":"Union{Nothing, IS.TimeSeriesKey}","null_value":"nothing","comment":"Variable Cost TimeSeriesKey"},{"name":"ancillary_services","default":"Vector{Service}()","data_type":"Vector{Service}","null_value":"Vector{Service}()","comment":"Bids for the ancillary services"}],"docstring":"Data Structure Operational Cost to reflect market bids of energy and ancilliary services.\nCompatible with most US Market bidding mechanisms","struct_name":"MarketBidCost","supertype":"OperationalCost"},{"fields":[{"name":"variable","data_type":"VariableCost","null_value":"VariableCost((0.0, 0.0))","comment":"variable cost"},{"name":"no_load","data_type":"Float64","null_value":"0.0","comment":"no load cost"},{"name":"fixed","data_type":"Float64","null_value":"0.0","comment":"fixed cost"},{"name":"start_up","data_type":"NamedTuple{(:hot, :warm, :cold), NTuple{3, Float64}}","null_value":"(hot = START_COST, warm = START_COST, cold = START_COST)","comment":"start-up cost"},{"name":"shut_down","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"shut-down cost","valid_range":{"max":null,"min":0}}],"docstring":"Data Structure Operational Cost Data which includes fixed, variable cost, multiple start up cost and stop costs.","struct_name":"MultiStartCost","supertype":"OperationalCost"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"peak_active_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"peak_reactive_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"load_response","default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"A collection of buses for control purposes.","struct_name":"Area","supertype":"AggregationTopology"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"peak_active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"peak_reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"A collection of buses for electricity price analysis.","struct_name":"LoadZone","supertype":"AggregationTopology"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"active_power_flow_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"violation_penalty","default":"INFINITE_COST","data_type":"Float64","null_value":"0.0","comment":"Penalty for violating the flow limits in the interface"},{"name":"direction_mapping","default":"Dict{String, Int}()","data_type":"Dict{String, Int}","null_value":"Dict{String, Int}()","comment":"Map to set of multiplier to the flow in the line for cases when the line has a reverse direction with respect to the interface"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"A collection of branches that make up an interface or corridor for the transfer of power.","struct_name":"TransmissionInterface","supertype":"Service"},{"inner_constructor_check":"check_bus_params","fields":[{"name":"number","data_type":"Int","null_value":"0","comment":"number associated with the bus"},{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init","comment":"the name of the bus"},{"name":"bustype","data_type":"Union{Nothing, ACBusTypes}","null_value":"nothing","comment":"bus type"},{"name":"angle","data_type":"Union{Nothing, Float64}","null_value":"0.0","validation_action":"error","comment":"angle of the bus in radians","valid_range":{"max":1.571,"min":-1.571}},{"name":"magnitude","data_type":"Union{Nothing, Float64}","null_value":"0.0","validation_action":"warn","comment":"voltage as a multiple of basevoltage","valid_range":"voltage_limits"},{"name":"voltage_limits","data_type":"Union{Nothing, MinMax}","null_value":"(min=0.0, max=0.0)","comment":"limits on the voltage variation as multiples of basevoltage"},{"name":"base_voltage","data_type":"Union{Nothing, Float64}","null_value":"nothing","validation_action":"error","comment":"the base voltage in kV","valid_range":{"max":null,"min":0}},{"name":"area","default":"nothing","data_type":"Union{Nothing, Area}","null_value":"nothing","comment":"the area containing the bus"},{"name":"load_zone","default":"nothing","data_type":"Union{Nothing, LoadZone}","null_value":"nothing","comment":"the load zone containing the bus"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"A power-system bus.","struct_name":"ACBus","supertype":"Bus"},{"fields":[{"name":"number","data_type":"Int","null_value":"0","comment":"number associated with the DC bus"},{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init","comment":"the name of the DC bus"},{"name":"magnitude","data_type":"Union{Nothing, Float64}","null_value":"0.0","validation_action":"warn","comment":"voltage as a multiple of basevoltage","valid_range":"voltage_limits"},{"name":"voltage_limits","data_type":"Union{Nothing, MinMax}","null_value":"(min=0.0, max=0.0)","comment":"limits on the voltage variation as multiples of basevoltage"},{"name":"base_voltage","data_type":"Union{Nothing, Float64}","null_value":"nothing","validation_action":"error","comment":"the base voltage in kV","valid_range":{"max":null,"min":0}},{"name":"area","default":"nothing","data_type":"Union{Nothing, Area}","null_value":"nothing","comment":"the area containing the DC bus"},{"name":"load_zone","default":"nothing","data_type":"Union{Nothing, LoadZone}","null_value":"nothing","comment":"the load zone containing the DC bus"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"A power-system DC bus.","struct_name":"DCBus","supertype":"Bus"},{"fields":[{"name":"from","data_type":"Bus","null_value":"ACBus(nothing)","comment":"The initial bus"},{"name":"to","data_type":"Bus","null_value":"ACBus(nothing)","comment":"The terminal bus"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"A topological Arc.","struct_name":"Arc","supertype":"Topology","custom_code":"get_name(arc::Arc) = (get_name ∘ get_from)(arc) * \" -> \" * (get_name ∘ get_to)(arc)"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"active_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"arc","data_type":"Arc","null_value":"Arc(ACBus(nothing), ACBus(nothing))"},{"name":"r","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":4,"min":0}},{"name":"x","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":4,"min":0}},{"name":"b","data_type":"FromTo","null_value":"(from=0.0, to=0.0)","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":100,"min":0}},{"name":"rate","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"angle_limits","data_type":"MinMax","null_value":"(min=-1.571, max=1.571)","validation_action":"error","valid_range":{"max":1.571,"min":-1.571}},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"Line","supertype":"ACBranch"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"active_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"arc","data_type":"Arc","null_value":"Arc(ACBus(nothing), ACBus(nothing))"},{"name":"r","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":4,"min":0}},{"name":"x","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":4,"min":0}},{"name":"b","data_type":"FromTo","null_value":"(from=0.0, to=0.0)","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":2,"min":0}},{"name":"flow_limits","needs_conversion":true,"data_type":"FromTo_ToFrom","null_value":"(from_to=0.0, to_from=0.0)","comment":"throw warning above max SIL"},{"name":"rate","needs_conversion":true,"data_type":"Float64","null_value":"0.0","comment":"compare to SIL (warn) (theoretical limit)"},{"name":"angle_limits","data_type":"MinMax","null_value":"(min=-1.571, max=1.571)","validation_action":"error","valid_range":{"max":1.571,"min":-1.571}},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"MonitoredLine","supertype":"ACBranch"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"active_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"arc","data_type":"Arc","null_value":"Arc(ACBus(nothing), ACBus(nothing))"},{"name":"r","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":4,"min":0}},{"name":"x","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":4,"min":-2}},{"name":"primary_shunt","Comment":"System per-unit value","data_type":"Float64","null_value":"0.0","validation_action":"warn","valid_range":{"max":2,"min":0}},{"name":"tap","data_type":"Float64","null_value":"1.0","validation_action":"error","valid_range":{"max":2,"min":0}},{"name":"α","data_type":"Float64","null_value":"0.0","validation_action":"warn","valid_range":{"max":1.571,"min":-1.571}},{"name":"rate","needs_conversion":true,"data_type":"Union{Nothing, Float64}","null_value":"0.0","validation_action":"error","valid_range":{"max":null,"min":0}},{"name":"phase_angle_limits","default":"(min=-1.571, max=1.571)","data_type":"MinMax","null_value":"(min=-1.571, max=1.571)","validation_action":"error","valid_range":{"max":1.571,"min":-1.571}},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"PhaseShiftingTransformer","supertype":"ACBranch"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"active_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"arc","data_type":"Arc","null_value":"Arc(ACBus(nothing), ACBus(nothing))"},{"name":"r","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":2,"min":-2}},{"name":"x","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":4,"min":-2}},{"name":"primary_shunt","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":2,"min":0}},{"name":"tap","data_type":"Float64","null_value":"1.0","validation_action":"error","valid_range":{"max":2,"min":0}},{"name":"rate","needs_conversion":true,"data_type":"Union{Nothing, Float64}","null_value":"0.0","validation_action":"error","valid_range":{"max":null,"min":0}},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"TapTransformer","supertype":"ACBranch"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"active_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"arc","data_type":"Arc","null_value":"Arc(ACBus(nothing), ACBus(nothing))"},{"name":"r","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":4,"min":-2}},{"name":"x","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":4,"min":-2}},{"name":"primary_shunt","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":2,"min":0}},{"name":"rate","needs_conversion":true,"data_type":"Union{Nothing, Float64}","null_value":"nothing","validation_action":"error","valid_range":{"max":null,"min":0}},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"The 2-W transformer model uses an equivalent circuit assuming the impedance is on the High Voltage Side of the transformer. The model allocates the iron losses and magnetizing susceptance to the primary side.","struct_name":"Transformer2W","supertype":"ACBranch"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"active_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"arc","data_type":"Arc","null_value":"Arc(ACBus(nothing), ACBus(nothing))"},{"name":"active_power_limits_from","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"active_power_limits_to","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"reactive_power_limits_from","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"reactive_power_limits_to","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"loss","data_type":"NamedTuple{(:l0, :l1), Tuple{Float64, Float64}}","null_value":"(l0=0.0, l1=0.0)"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"a High voltage DC line.","struct_name":"TwoTerminalHVDCLine","supertype":"ACBranch"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"active_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"arc","data_type":"Arc","null_value":"Arc(ACBus(nothing), ACBus(nothing))"},{"name":"rectifier_tap_limits","data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"rectifier_xrc","data_type":"Float64","null_value":"0.0"},{"name":"rectifier_firing_angle","data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"inverter_tap_limits","data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"inverter_xrc","data_type":"Float64","null_value":"0.0"},{"name":"inverter_firing_angle","data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"As implemented in Milano's Book, Page 397.","struct_name":"TwoTerminalVSCDCLine","supertype":"ACBranch"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"active_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"arc","data_type":"Arc","null_value":"Arc(DCBus(nothing), DCBus(nothing))"},{"name":"r","data_type":"Float64","null_value":"0.0","comment":"Series Resistance system per-unit value"},{"name":"l","data_type":"Float64","null_value":"0.0","comment":"Series Inductance system per-unit value"},{"name":"c","data_type":"Float64","null_value":"0.0","comment":"Shunt capacitance system per-unit value"},{"name":"active_power_limits_from","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"active_power_limits_to","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"a HVDC T-Model DC line.","struct_name":"TModelHVDCLine","supertype":"DCBranch"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"max_active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"max_reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"operation_cost","data_type":"TwoPartCost","null_value":"TwoPartCost(nothing)","comment":"Operation Cost of Generation [`TwoPartCost`](@ref)"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"InterruptiblePowerLoad","supertype":"ControllableLoad"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"Y","data_type":"Complex{Float64}","null_value":"0.0","comment":"System per-unit value"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection model for admittance"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"FixedAdmittance","supertype":"ElectricLoad"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"Y","data_type":"Complex{Float64}","null_value":"0.0","comment":"Initial impedance at N = 0"},{"name":"number_of_steps","default":"0","data_type":"Int","null_value":"0","comment":"Number of steps for adjustable shunt"},{"name":"Y_increase","default":"0","data_type":"Complex{Float64}","null_value":"0","comment":"Admittance increment for each of step increase"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection model for admittance"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"SwitchedAdmittance","supertype":"ElectricLoad"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"max_active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"max_reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data structure for a static power load.","struct_name":"PowerLoad","supertype":"StaticLoad"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"constant_active_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"constant_reactive_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"impedance_active_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"impedance_reactive_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"current_active_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"current_reactive_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"max_constant_active_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"max_constant_reactive_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"max_impedance_active_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"max_impedance_reactive_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"max_current_active_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"max_current_reactive_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data structure for a standard load.","struct_name":"StandardLoad","supertype":"StaticLoad"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"active_power_coefficient","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Coefficient relating voltage dependence for power P = P0 * V^α","valid_range":{"max":null,"min":0}},{"name":"reactive_power_coefficient","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Coefficient relating voltage dependence for power Q = Q0 * V^β","valid_range":{"max":null,"min":0}},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"max_active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"max_reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data structure for a static exponential load.","struct_name":"ExponentialLoad","supertype":"StaticLoad"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"R_s","data_type":"Float64","null_value":0,"comment":"Armature stator resistance","valid_range":{"max":null,"min":0}},{"name":"R_r","data_type":"Float64","null_value":0,"comment":"Rotor resistance","valid_range":{"max":null,"min":0}},{"name":"X_ls","data_type":"Float64","null_value":0,"comment":"Stator Leakage Reactance","valid_range":{"max":null,"min":0}},{"name":"X_lr","data_type":"Float64","null_value":0,"comment":"Rotor Leakage Reactance","valid_range":{"max":null,"min":0}},{"name":"X_m","data_type":"Float64","null_value":0,"comment":"Stator-Rotor Mutual Reactance","valid_range":{"max":null,"min":0}},{"name":"H","data_type":"Float64","null_value":0,"comment":"Motor Inertia Constant [s]","valid_range":{"max":null,"min":0}},{"name":"A","data_type":"Float64","null_value":"0.0","comment":"Torque-Speed Quadratic Term","valid_range":{"max":1,"min":0}},{"name":"B","data_type":"Float64","null_value":"0.0","comment":"Torque-Speed Linear Term","valid_range":{"max":1,"min":0}},{"name":"base_power","data_type":"Float64","null_value":0,"comment":"Base power","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"C","data_type":"Float64","comment":"Torque-Speed Constant Term","internal_default":"PowerSystems.calculate_IM_torque_params(A, B)"},{"name":"τ_ref","data_type":"Float64","comment":"Reference torque parameter","internal_default":"1.0"},{"name":"B_shunt","data_type":"Float64","comment":"Susceptance Initialization Corrector Term","internal_default":"0.0"},{"name":"X_ad","data_type":"Float64","comment":"Equivalent d-axis reactance","internal_default":"(1.0 / X_m + 1.0 / X_ls + 1.0 / X_lr)^(-1)"},{"name":"X_aq","data_type":"Float64","comment":"Equivalent q-axis reactance","internal_default":"X_ad"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tψ_qs: stator flux in the q-axis,\n\tψ_ds: stator flux in the d-axis,\n\tψ_qr: rotor flux in the q-axis,\n\tψ_dr: rotor flux in the d-axis, \n\tωr: Rotor speed [pu],","internal_default":"[:ψ_qs, :ψ_ds, :ψ_qr, :ψ_dr, :ωr]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"SingleCageInductionMachine has 5 states","internal_default":5},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 5-states three-phase single cage induction machine with quadratic torque-speed relationship.","struct_name":"SingleCageInductionMachine","supertype":"DynamicInjection"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"R_s","data_type":"Float64","null_value":0,"comment":"Armature stator resistance","valid_range":{"max":null,"min":0}},{"name":"R_r","data_type":"Float64","null_value":0,"comment":"Rotor resistance","valid_range":{"max":null,"min":0}},{"name":"X_ls","data_type":"Float64","null_value":0,"comment":"Stator Leakage Reactance","valid_range":{"max":null,"min":0}},{"name":"X_lr","data_type":"Float64","null_value":0,"comment":"Rotor Leakage Reactance","valid_range":{"max":null,"min":0}},{"name":"X_m","data_type":"Float64","null_value":0,"comment":"Stator-Rotor Mutual Reactance","valid_range":{"max":null,"min":0}},{"name":"H","data_type":"Float64","null_value":0,"comment":"Motor Inertia Constant [s]","valid_range":{"max":null,"min":0}},{"name":"A","data_type":"Float64","null_value":"0.0","comment":"Torque-Speed Quadratic Term","valid_range":{"max":1,"min":0}},{"name":"B","data_type":"Float64","null_value":"0.0","comment":"Torque-Speed Linear Term","valid_range":{"max":1,"min":0}},{"name":"base_power","data_type":"Float64","null_value":0,"comment":"Base power","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"C","data_type":"Float64","comment":"Torque-Speed Constant Term","internal_default":"PowerSystems.calculate_IM_torque_params(A, B)"},{"name":"τ_ref","data_type":"Float64","comment":"Reference torque parameter","internal_default":"1.0"},{"name":"B_shunt","data_type":"Float64","comment":"Susceptance Initialization Corrector Term","internal_default":"0.0"},{"name":"X_ss","data_type":"Float64","comment":"Stator self reactance","internal_default":"X_ls + X_m"},{"name":"X_rr","data_type":"Float64","comment":"Rotor self reactance","internal_default":"X_lr + X_m"},{"name":"X_p","data_type":"Float64","comment":"Transient reactance","internal_default":"X_ss - X_m^2 / X_rr"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tψ_qr: rotor flux in the q-axis,\n\tψ_dr: rotor flux in the d-axis, \n\tωr: Rotor speed [pu],","internal_default":"[:ψ_qr, :ψ_dr, :ωr]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"SimplifiedSingleCageInductionMachine has 3 states","internal_default":3},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 3-states three-phase single cage induction machine with quadratic torque-speed relationship.","struct_name":"SimplifiedSingleCageInductionMachine","supertype":"DynamicInjection"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"a","data_type":"Float64","null_value":0,"comment":"Active power static exponential coefficient","valid_range":{"max":null,"min":0}},{"name":"b","data_type":"Float64","null_value":0,"comment":"Reactive power static exponential coefficient","valid_range":{"max":null,"min":0}},{"name":"α","data_type":"Float64","null_value":0,"comment":"Active power transient exponential coefficient","valid_range":{"max":null,"min":0}},{"name":"β","data_type":"Float64","null_value":0,"comment":"Reactive power transient exponential coefficient","valid_range":{"max":null,"min":0}},{"name":"T_p","data_type":"Float64","null_value":0,"comment":"Active Power Time Constant","valid_range":{"max":null,"min":0}},{"name":"T_q","data_type":"Float64","null_value":0,"comment":"Reactive Power Time Constant","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"base_power","data_type":"Float64","comment":"Base Power","internal_default":"100.0"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tx_p: Integrator state of the active power,\n\tx_q: Integrator state of the reactive power,","internal_default":"[:x_p, :x_q]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"DynamicExponentialLoad has 2 states","internal_default":2},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 2-states of a generic dynamic load model based on VOLTAGE STABILITY ANALYSIS USING GENERIC DYNAMIC LOAD MODELS by W. Xu and Y. Mansour, IEEE Transactions on Power Systems, 1994.","struct_name":"DynamicExponentialLoad","supertype":"DynamicInjection"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"r_load","data_type":"Float64","null_value":0,"comment":"DC-side resistor","valid_range":{"max":null,"min":0}},{"name":"c_dc","data_type":"Float64","null_value":0,"comment":"DC-side capacitor","valid_range":{"max":null,"min":0}},{"name":"rf","data_type":"Float64","null_value":0,"comment":"Converter side filter resistance","valid_range":{"max":null,"min":0}},{"name":"lf","data_type":"Float64","null_value":0,"comment":"Converter side filter inductance","valid_range":{"max":null,"min":0}},{"name":"cf","data_type":"Float64","null_value":0,"comment":"AC Converter filter capacitance","valid_range":{"max":null,"min":0}},{"name":"rg","data_type":"Float64","null_value":0,"comment":"Network side filter resistance","valid_range":{"max":null,"min":0}},{"name":"lg","data_type":"Float64","null_value":0,"comment":"Network side filter inductance","valid_range":{"max":null,"min":0}},{"name":"kp_pll","data_type":"Float64","null_value":0,"comment":"Proportional constant for PI-PLL block","valid_range":{"max":null,"min":0}},{"name":"ki_pll","data_type":"Float64","null_value":0,"comment":"Integral constant for PI-PLL block","valid_range":{"max":null,"min":0}},{"name":"kpv","data_type":"Float64","null_value":0,"comment":"Proportional constant for Voltage Control block","valid_range":{"max":null,"min":0}},{"name":"kiv","data_type":"Float64","null_value":0,"comment":"Integral constant for Voltage Control block","valid_range":{"max":null,"min":0}},{"name":"kpc","data_type":"Float64","null_value":0,"comment":"Proportional constant for Current Control block","valid_range":{"max":null,"min":0}},{"name":"kic","data_type":"Float64","null_value":0,"comment":"Integral constant for Current Control block","valid_range":{"max":null,"min":0}},{"name":"base_power","data_type":"Float64","null_value":0,"comment":"Base power","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"P_ref","data_type":"Float64","comment":"Reference active power parameter","internal_default":"1.0"},{"name":"Q_ref","data_type":"Float64","comment":"Reference reactive power parameter","internal_default":"1.0"},{"name":"V_ref","data_type":"Float64","comment":"Reference voltage parameter","internal_default":"1.0"},{"name":"ω_ref","data_type":"Float64","comment":"Reference frequency parameter","internal_default":"1.0"},{"name":"is_filter_differential","data_type":"Int","comment":"Boolean to decide if filter states are differential or algebraic","internal_default":"1"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tθ_pll: PLL deviation angle, \n\tϵ_pll: PLL integrator state, \n\tη: DC-voltage controller integrator state, \n\tv_dc: DC voltage at the capacitor, \n\tγd: d-axis Current controller integrator state, \n\tγq: q-axis Current controller integrator state, \n\tir_cnv: Real current out of the converter,\n\tii_cnv: Imaginary current out of the converter,\n\tvr_filter: Real voltage at the filter's capacitor,\n\tvi_filter: Imaginary voltage at the filter's capacitor,\n\tir_filter: Real current out of the filter,\n\tii_filter: Imaginary current out of the filter","internal_default":"[:θ_pll, :ϵ_pll, :η, :v_dc, :γd, :γq, :ir_cnv, :ii_cnv, :vr_filter, :vi_filter, :ir_filter, :ii_filter]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ActiveConstantPowerLoad has 12 states","internal_default":12},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 12-states active power load based on the paper Dynamic Stability of a Microgrid With an Active Load from N. Bottrell, M. Prodanovic and T. Green in IEEE Transactions on Power Electronics, 2013.","struct_name":"ActiveConstantPowerLoad","supertype":"DynamicInjection"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"dc_bus","data_type":"DCBus","null_value":"DCBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Active Power on the DCSide","valid_range":"active_power_limits"},{"name":"rating","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Thermal limited MVA Power Output of the converter. <= Capacity","valid_range":{"max":null,"min":0}},{"name":"active_power_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the converter in MVA","valid_range":{"max":null,"min":0}},{"name":"operation_cost","default":"TwoPartCost(0.0, 0.0)","data_type":"OperationalCost","null_value":"TwoPartCost(nothing)","comment":"Operation Cost of Generation [`OperationalCost`](@ref)"},{"name":"efficiency","default":"1.0","data_type":"Float64","null_value":"0.0","comment":"Conversion efficiency from AC Power to DC Power"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Interconnecting Power Converter (IPC) for transforming power from an ACBus to a DCBus","struct_name":"InterconnectingConverter","supertype":"StaticInjection"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"K","data_type":"Float64","null_value":0,"comment":"Gain in pu","valid_range":{"max":null,"min":0}},{"name":"T1","data_type":"Float64","null_value":0,"comment":"Time constant in s","valid_range":{"max":null,"min":0}},{"name":"T2","data_type":"Float64","null_value":0,"comment":"Time constant in s","valid_range":{"max":null,"min":0}},{"name":"T3","data_type":"Float64","null_value":0,"comment":"Time constant in s","valid_range":{"max":null,"min":"eps()"}},{"name":"T4","data_type":"Float64","null_value":0,"comment":"Time constant in s","valid_range":{"max":null,"min":0}},{"name":"T5","data_type":"Float64","null_value":0,"comment":"Time constant in s","valid_range":{"max":null,"min":0}},{"name":"Rmin","data_type":"Float64","null_value":0,"comment":"Reactor minimum Mvar","valid_range":{"max":null,"min":0}},{"name":"Vmax","data_type":"Float64","null_value":0,"comment":"Maximum voltage in pu","valid_range":{"max":null,"min":0}},{"name":"Vmin","data_type":"Float64","null_value":0,"comment":"Minimum voltage in pu","valid_range":{"max":null,"min":0}},{"name":"CBase","data_type":"Float64","null_value":0,"comment":"Capacitor Mvar","valid_range":{"max":null,"min":0}},{"name":"base_power","data_type":"Float64","null_value":0,"comment":"Base power","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"R_th","data_type":"Float64","comment":"Source Thevenin resistance","internal_default":"0.0"},{"name":"X_th","data_type":"Float64","comment":"Source Thevenin reactance","internal_default":"0.0"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tthy: thyristor,\n\tvr1: regulator output 1,\n\tvr2: regulator output 2","internal_default":"[:thy, :vr1, :vr2]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"CSVGN1 has 3 states","internal_default":3},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of static shunt compensator: CSVGN1 in PSSE","struct_name":"CSVGN1","supertype":"DynamicInjection"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"warn","valid_range":"reactive_power_limits"},{"name":"rating","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Thermal limited MVA Power Output of the unit. <= Capacity","valid_range":{"max":null,"min":0}},{"name":"prime_mover_type","data_type":"PrimeMovers","null_value":"PrimeMovers.HY","comment":"Prime mover technology according to EIA 923"},{"name":"active_power_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"reactive_power_limits","needs_conversion":true,"data_type":"Union{Nothing, MinMax}","null_value":"nothing","validation_action":"warn"},{"name":"ramp_limits","needs_conversion":true,"data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"ramp up and ramp down limits in MW (in component base per unit) per minute","valid_range":{"max":null,"min":0}},{"name":"time_limits","data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"Minimum up and Minimum down time limits in hours","valid_range":{"max":null,"min":0}},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"storage_capacity","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Maximum storage capacity in the reservoir (units can be p.u-hr or m^3).","valid_range":{"max":null,"min":0}},{"name":"inflow","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Baseline inflow into the reservoir (units can be p.u. or m^3/hr)","valid_range":{"max":null,"min":0}},{"name":"initial_storage","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Initial storage capacity in the reservoir (units can be p.u-hr or m^3).","valid_range":{"max":null,"min":0}},{"name":"operation_cost","default":"TwoPartCost(0.0, 0.0)","data_type":"OperationalCost","null_value":"TwoPartCost(nothing)","comment":"Operation Cost of Generation [`OperationalCost`](@ref)"},{"name":"storage_target","default":"1.0","data_type":"Float64","null_value":"0.0","comment":"Storage target at the end of simulation as ratio of storage capacity."},{"name":"conversion_factor","default":"1.0","data_type":"Float64","null_value":"0.0","comment":"Conversion factor from flow/volume to energy: m^3 -> p.u-hr."},{"name":"time_at_status","default":"INFINITE_TIME","data_type":"Float64","null_value":"INFINITE_TIME"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"HydroEnergyReservoir","supertype":"HydroGen"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"warn","valid_range":"reactive_power_limits"},{"name":"rating","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Thermal limited MVA Power Output of the unit. <= Capacity","valid_range":{"max":null,"min":0}},{"name":"prime_mover_type","data_type":"PrimeMovers","null_value":"PrimeMovers.HY","comment":"Prime mover technology according to EIA 923"},{"name":"active_power_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)","validation_action":"warn","valid_range":{"max":null,"min":0}},{"name":"reactive_power_limits","needs_conversion":true,"data_type":"Union{Nothing, MinMax}","null_value":"nothing","validation_action":"warn"},{"name":"ramp_limits","needs_conversion":true,"data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"ramp up and ramp down limits in MW (in component base per unit) per minute","valid_range":{"max":null,"min":0}},{"name":"time_limits","data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"Minimum up and Minimum down time limits in hours","valid_range":{"max":null,"min":0}},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"operation_cost","default":"TwoPartCost(0.0, 0.0)","data_type":"OperationalCost","null_value":"TwoPartCost(nothing)","comment":"Operation Cost of Generation [`OperationalCost`](@ref)"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"HydroDispatch","supertype":"HydroGen"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"rating","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Thermal limited MVA Power Output of the unit. <= Capacity","valid_range":{"max":null,"min":0}},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"prime_mover_type","data_type":"PrimeMovers","null_value":"PrimeMovers.HY","comment":"Prime mover technology according to EIA 923"},{"name":"active_power_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)","validation_action":"warn","valid_range":{"max":null,"min":0}},{"name":"reactive_power_limits","needs_conversion":true,"data_type":"Union{Nothing, MinMax}","null_value":"nothing","validation_action":"warn"},{"name":"ramp_limits","needs_conversion":true,"data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"ramp up and ramp down limits in MW (in component base per unit) per minute","valid_range":{"max":null,"min":0}},{"name":"time_limits","data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"Minimum up and Minimum down time limits in hours","valid_range":{"max":null,"min":0}},{"name":"rating_pump","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Thermal limited MVA Power Withdrawl of the pump. <= Capacity","valid_range":{"max":null,"min":0}},{"name":"active_power_limits_pump","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"reactive_power_limits_pump","needs_conversion":true,"data_type":"Union{Nothing, MinMax}","null_value":"nothing","validation_action":"warn"},{"name":"ramp_limits_pump","needs_conversion":true,"data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"ramp up and ramp down limits in MW (in component base per unit) per minute of pump","valid_range":{"max":null,"min":0}},{"name":"time_limits_pump","data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"Minimum up and Minimum down time limits of pump in hours","valid_range":{"max":null,"min":0}},{"name":"storage_capacity","needs_conversion":true,"data_type":"UpDown","null_value":"(up=0.0, down=0.0)","validation_action":"error","comment":"Maximum storage capacity in the upper and lower reservoirs (units can be p.u-hr or m^3).","valid_range":{"max":null,"min":0}},{"name":"inflow","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Baseline inflow into the upper reservoir (units can be p.u. or m^3/hr)","valid_range":{"max":null,"min":0}},{"name":"outflow","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Baseline outflow from the lower reservoir (units can be p.u. or m^3/hr)","valid_range":{"max":null,"min":0}},{"name":"initial_storage","needs_conversion":true,"data_type":"UpDown","null_value":"(up=0.0, down=0.0)","validation_action":"error","comment":"Initial storage capacity in the upper and lower reservoir (units can be p.u-hr or m^3).","valid_range":{"max":null,"min":0}},{"name":"storage_target","default":"(up=1.0, down=1.0)","data_type":"UpDown","null_value":"(up=0.0, down=0.0)","comment":"Storage target of upper reservoir at the end of simulation as ratio of storage capacity."},{"name":"operation_cost","default":"TwoPartCost(0.0, 0.0)","data_type":"OperationalCost","null_value":"TwoPartCost(nothing)","comment":"Operation Cost of Generation [`OperationalCost`](@ref)"},{"name":"pump_efficiency","default":"1.0","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Efficiency of pump","valid_range":{"max":1,"min":0}},{"name":"conversion_factor","default":"1.0","data_type":"Float64","null_value":"0.0","comment":"Conversion factor from flow/volume to energy: m^3 -> p.u-hr."},{"name":"time_at_status","default":"INFINITE_TIME","data_type":"Float64","null_value":"INFINITE_TIME"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"HydroPumpedStorage","supertype":"HydroGen"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"rating","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Thermal limited MVA Power Output of the unit. <= Capacity","valid_range":{"max":null,"min":0}},{"name":"prime_mover_type","data_type":"PrimeMovers","null_value":"PrimeMovers.OT","comment":"Prime mover technology according to EIA 923"},{"name":"reactive_power_limits","needs_conversion":true,"data_type":"Union{Nothing, MinMax}","null_value":"nothing"},{"name":"power_factor","data_type":"Float64","null_value":"1.0","validation_action":"error","valid_range":{"max":1,"min":0}},{"name":"operation_cost","data_type":"TwoPartCost","null_value":"TwoPartCost(nothing)","comment":"Operation Cost of Generation [`TwoPartCost`](@ref)"},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"RenewableDispatch","supertype":"RenewableGen"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"rating","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Thermal limited MVA Power Output of the unit. <= Capacity","valid_range":{"max":null,"min":0}},{"name":"prime_mover_type","data_type":"PrimeMovers","null_value":"PrimeMovers.OT","comment":"Prime mover technology according to EIA 923"},{"name":"power_factor","data_type":"Float64","null_value":"1.0","validation_action":"error","valid_range":{"max":1,"min":0}},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data Structure for fixed renewable generation technologies.","struct_name":"RenewableFix","supertype":"RenewableGen"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"status","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"warn","valid_range":"active_power_limits"},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"warn","valid_range":"reactive_power_limits"},{"name":"rating","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Thermal limited MVA Power Output of the unit. <= Capacity","valid_range":{"max":null,"min":0}},{"name":"active_power_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)","validation_action":"warn","valid_range":{"max":null,"min":0}},{"name":"reactive_power_limits","needs_conversion":true,"data_type":"Union{Nothing, MinMax}","null_value":"nothing"},{"name":"ramp_limits","needs_conversion":true,"data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"ramp up and ramp down limits in MW (in component base per unit) per minute","valid_range":{"max":null,"min":0}},{"name":"operation_cost","data_type":"OperationalCost","null_value":"ThreePartCost(nothing)"},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"time_limits","default":"nothing","data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"Minimum up and Minimum down time limits in hours","valid_range":{"max":null,"min":0}},{"name":"must_run","default":"false","data_type":"Bool","null_value":"false"},{"name":"prime_mover_type","default":"PrimeMovers.OT","data_type":"PrimeMovers","null_value":"PrimeMovers.OT","comment":"Prime mover technology according to EIA 923"},{"name":"fuel","default":"ThermalFuels.OTHER","data_type":"ThermalFuels","null_value":"ThermalFuels.OTHER","comment":"Prime mover fuel according to EIA 923"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"time_at_status","default":"INFINITE_TIME","data_type":"Float64","null_value":"INFINITE_TIME"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data Structure for thermal generation technologies.","struct_name":"ThermalStandard","supertype":"ThermalGen"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"status","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"warn","valid_range":"active_power_limits"},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"warn","valid_range":"reactive_power_limits"},{"name":"rating","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Thermal limited MVA Power Output of the unit. <= Capacity","valid_range":{"max":null,"min":0}},{"name":"prime_mover_type","data_type":"PrimeMovers","null_value":"PrimeMovers.OT","comment":"Prime mover technology according to EIA 923"},{"name":"fuel","data_type":"ThermalFuels","null_value":"ThermalFuels.OTHER","comment":"Prime mover fuel according to EIA 923"},{"name":"active_power_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"reactive_power_limits","needs_conversion":true,"data_type":"Union{Nothing, MinMax}","null_value":"nothing"},{"name":"ramp_limits","needs_conversion":true,"data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","valid_range":{"max":null,"min":0}},{"name":"power_trajectory","needs_conversion":true,"data_type":"Union{Nothing, StartUpShutDown}","null_value":"nothing","validation_action":"error","comment":"Power trajectory the unit will take during the start-up and shut-down ramp process","valid_range":{"max":null,"min":0}},{"name":"time_limits","data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"Minimum up and Minimum down time limits in hours","valid_range":{"max":null,"min":0}},{"name":"start_time_limits","data_type":"Union{Nothing, NamedTuple{(:hot, :warm, :cold), Tuple{Float64, Float64, Float64}}}","null_value":"nothing","comment":" Time limits for start-up based on turbine temperature in hours"},{"name":"start_types","data_type":"Int","null_value":"1","validation_action":"error","comment":" Number of start-up based on turbine temperature","valid_range":{"max":3,"min":1}},{"name":"operation_cost","data_type":"OperationalCost","null_value":"MultiStartCost(nothing)"},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"time_at_status","default":"INFINITE_TIME","data_type":"Float64","null_value":"INFINITE_TIME"},{"name":"must_run","default":"false","data_type":"Bool","null_value":"false"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data Structure for thermal generation technologies.","struct_name":"ThermalMultiStart","supertype":"ThermalGen"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"prime_mover_type","data_type":"PrimeMovers","null_value":"PrimeMovers.BA","comment":"Prime mover technology according to EIA 923"},{"name":"initial_energy","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"State of Charge of the Battery p.u.-hr","valid_range":{"max":null,"min":0}},{"name":"state_of_charge_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)","validation_action":"error","comment":"Maximum and Minimum storage capacity in p.u.-hr","valid_range":{"max":null,"min":0}},{"name":"rating","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"input_active_power_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)","validation_action":"error","valid_range":{"max":null,"min":0}},{"name":"output_active_power_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)","validation_action":"error","valid_range":{"max":null,"min":0}},{"name":"efficiency","data_type":"NamedTuple{(:in, :out), Tuple{Float64, Float64}}","null_value":"(in=0.0, out=0.0)","validation_action":"warn","valid_range":{"max":1,"min":0}},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"warn","valid_range":"reactive_power_limits"},{"name":"reactive_power_limits","needs_conversion":true,"data_type":"Union{Nothing, MinMax}","null_value":"(min=0.0, max=0.0)"},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"operation_cost","default":"StorageManagementCost()","data_type":"Union{StorageManagementCost, MarketBidCost}","null_value":"StorageManagementCost()"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data structure for a generic battery","struct_name":"GenericBattery","supertype":"Storage"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"prime_mover_type","data_type":"PrimeMovers","null_value":"PrimeMovers.BA","comment":"Prime mover technology according to EIA 923"},{"name":"initial_energy","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"State of Charge of the Battery p.u.-hr","valid_range":{"max":null,"min":0}},{"name":"state_of_charge_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)","validation_action":"error","comment":"Maximum and Minimum storage capacity in p.u.-hr","valid_range":{"max":null,"min":0}},{"name":"rating","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"input_active_power_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)","validation_action":"error","valid_range":{"max":null,"min":0}},{"name":"output_active_power_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)","validation_action":"error","valid_range":{"max":null,"min":0}},{"name":"efficiency","data_type":"NamedTuple{(:in, :out), Tuple{Float64, Float64}}","null_value":"(in=0.0, out=0.0)","validation_action":"warn","valid_range":{"max":1,"min":0}},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"warn","valid_range":"reactive_power_limits"},{"name":"reactive_power_limits","needs_conversion":true,"data_type":"Union{Nothing, MinMax}","null_value":"(min=0.0, max=0.0)"},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"operation_cost","default":"Union{StorageManagementCost, MarketBidCost}","data_type":"StorageManagementCost","null_value":"StorageManagementCost()"},{"name":"storage_target","default":"0.0","data_type":"Float64","null_value":"0.0","comment":"Storage target at the end of simulation as ratio of storage capacity."},{"name":"cycle_limits","default":"1e4","data_type":"Int","null_value":"0","comment":"Storage Maximum number of cycles per year"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data structure for a battery compatible with energy management formulations.","struct_name":"BatteryEMS","supertype":"Storage"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"time_frame","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the saturation time_frame in minutes to provide reserve contribution","valid_range":{"max":null,"min":0}},{"name":"requirement","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the static value of required reserves in system p.u.","valid_range":{"max":null,"min":0}},{"name":"sustained_time","default":"3600.0","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the time in secounds reserve contribution must sustained at a specified level","valid_range":{"max":null,"min":0}},{"name":"max_output_fraction","default":"1.0","data_type":"Float64","null_value":"1.0","validation_action":"error","comment":"the maximum fraction of the device's output that can be assigned to the service","valid_range":{"max":1,"min":0}},{"name":"max_participation_factor","default":"1.0","data_type":"Float64","null_value":"1.0","validation_action":"error","comment":"the maximum limit of reserve contribution per device","valid_range":{"max":1,"min":0}},{"name":"deployed_fraction","default":"0.0","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Fraction of ancillary services participation deployed from the assignment","valid_range":{"max":1,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data Structure for a proportional reserve product for system simulations.","parametric":"ReserveDirection","struct_name":"StaticReserve","supertype":"Reserve{T}"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"time_frame","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the saturation time_frame in minutes to provide reserve contribution","valid_range":{"max":null,"min":0}},{"name":"requirement","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the static value of required reserves in system p.u.","valid_range":{"max":null,"min":0}},{"name":"sustained_time","default":"3600.0","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the time in secounds reserve contribution must sustained at a specified level","valid_range":{"max":null,"min":0}},{"name":"max_output_fraction","default":"1.0","data_type":"Float64","null_value":"1.0","validation_action":"error","comment":"the maximum fraction of the device's output that can be assigned to the service","valid_range":{"max":1,"min":0}},{"name":"max_participation_factor","default":"1.0","data_type":"Float64","null_value":"1.0","validation_action":"error","comment":"the maximum limit of reserve contribution per device","valid_range":{"max":1,"min":0}},{"name":"deployed_fraction","default":"0.0","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Fraction of ancillary services participation deployed from the assignment","valid_range":{"max":1,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data Structure for a non-spinning reserve product for system simulations.","struct_name":"StaticReserveNonSpinning","supertype":"ReserveNonSpinning"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"requirement","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the static value of required reserves in system p.u.","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"contributing_services","default":"Vector{Service}()","data_type":"Vector{Service}","exclude_setter":true,"null_value":"Vector{Service}()","comment":"Services that contribute for this requirement constraint"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data Structure for a group reserve product for system simulations.","parametric":"ReserveDirection","struct_name":"StaticReserveGroup","supertype":"Service"},{"fields":[{"name":"variable","data_type":"Union{Nothing, IS.TimeSeriesKey}","null_value":"nothing","comment":"Variable Cost TimeSeriesKey"},{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"time_frame","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the saturation time_frame in minutes to provide reserve contribution","valid_range":{"max":null,"min":0}},{"name":"sustained_time","default":"3600.0","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the time in secounds reserve contribution must sustained at a specified level","valid_range":{"max":null,"min":0}},{"name":"max_participation_factor","default":"1.0","data_type":"Float64","null_value":"1.0","validation_action":"error","comment":"the maximum limit of reserve contribution per device","valid_range":{"max":1,"min":0}},{"name":"deployed_fraction","default":"0.0","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Fraction of ancillary services participation deployed from the assignment","valid_range":{"max":1,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data Structure for a operating reserve with demand curve product for system simulations.","parametric":"ReserveDirection","struct_name":"ReserveDemandCurve","supertype":"Reserve{T}"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"time_frame","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the saturation time_frame in minutes to provide reserve contribution","valid_range":{"max":null,"min":0}},{"name":"requirement","data_type":"Float64","null_value":"0.0","comment":"the required quantity of the product should be scaled by a TimeSeriesData"},{"name":"sustained_time","default":"3600.0","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the time in secounds reserve contribution must sustained at a specified level","valid_range":{"max":null,"min":0}},{"name":"max_output_fraction","default":"1.0","data_type":"Float64","null_value":"1.0","validation_action":"error","comment":"the maximum fraction of the device's output that can be assigned to the service","valid_range":{"max":1,"min":0}},{"name":"max_participation_factor","default":"1.0","data_type":"Float64","null_value":"1.0","validation_action":"error","comment":"the maximum limit of reserve contribution per device","valid_range":{"max":1,"min":0}},{"name":"deployed_fraction","default":"0.0","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Fraction of ancillary services participation deployed from the assignment","valid_range":{"max":1,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data Structure for the procurement products for system simulations.","parametric":"ReserveDirection","struct_name":"VariableReserve","supertype":"Reserve{T}"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"time_frame","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the saturation time_frame in minutes to provide reserve contribution","valid_range":{"max":null,"min":0}},{"name":"requirement","needs_conversion":true,"data_type":"Float64","null_value":"0.0","comment":"the required quantity of the product should be scaled by a TimeSeriesData"},{"name":"sustained_time","default":"14400.0","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the time in secounds reserve contribution must sustained at a specified level","valid_range":{"max":null,"min":0}},{"name":"max_output_fraction","default":"1.0","data_type":"Float64","null_value":"1.0","validation_action":"error","comment":"the maximum fraction of the device's output that can be assigned to the service","valid_range":{"max":1,"min":0}},{"name":"max_participation_factor","default":"1.0","data_type":"Float64","null_value":"1.0","validation_action":"error","comment":"the maximum limit of reserve contribution per device","valid_range":{"max":1,"min":0}},{"name":"deployed_fraction","default":"0.0","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Fraction of ancillary services participation deployed from the assignment","valid_range":{"max":1,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data Structure for the procurement products for system simulations.","struct_name":"VariableReserveNonSpinning","supertype":"ReserveNonSpinning"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bias","data_type":"Float64","null_value":"0.0"},{"name":"K_p","data_type":"Float64","null_value":"0.0","comment":"PID Proportional Constant"},{"name":"K_i","data_type":"Float64","null_value":"0.0","comment":"PID Integral Constant"},{"name":"K_d","data_type":"Float64","null_value":"0.0","comment":"PID Derrivative Constant"},{"name":"delta_t","data_type":"Float64","null_value":"0.0","comment":"PID Discretization period [Seconds]"},{"name":"area","default":"nothing","data_type":"Union{Nothing, Area}","null_value":"Area(nothing)","comment":"the area controlled by the AGC"},{"name":"initial_ace","default":"0.0","data_type":"Float64","null_value":"0.0","comment":"PID Discretization period [Seconds]"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"AGC","supertype":"Service"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"requirement","data_type":"Float64","null_value":"0.0"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"Transfer","supertype":"Service"},{"fields":[{"name":"Vf","data_type":"Float64","null_value":0,"comment":"Fixed voltage field applied to the rotor winding","valid_range":{"max":null,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"Fixed AVR has no states","internal_default":"Vector{Symbol}()"},{"name":"n_states","data_type":"Int","exclude_setter":true,"null_value":0,"comment":"Fixed AVR has no states","internal_default":0},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"Fixed AVR has no states","internal_default":"Vector{StateTypes}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of a AVR that returns a fixed voltage to the rotor winding","struct_name":"AVRFixed","supertype":"AVR"},{"fields":[{"name":"Kv","data_type":"Float64","null_value":0,"comment":"Proportional Gain","valid_range":{"max":null,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVf: field voltage","internal_default":"[:Vf]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"Fixed AVR has 1 states","internal_default":1},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"Simple AVR has 1 differential states","internal_default":"[StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of a simple proportional AVR in the derivative of EMF\ni.e. an integrator controller on EMF","struct_name":"AVRSimple","supertype":"AVR"},{"fields":[{"name":"Ta_Tb","data_type":"Float64","null_value":0,"comment":"Ratio of lead and lag time constants","valid_range":{"max":null,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"comment":"Lag time constant","valid_range":{"max":null,"min":"eps()"}},{"name":"K","data_type":"Float64","null_value":0,"comment":"Gain","valid_range":{"max":null,"min":0}},{"name":"Te","data_type":"Float64","null_value":0,"comment":"Field circuit time constant in s","valid_range":{"max":null,"min":0}},{"name":"V_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Field voltage limits"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\tVf: Voltage field,\tVr: Lead-lag state","internal_default":"[:Vf, :Vr]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"SEXS has 2 states","internal_default":2},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"SEXS has 2 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of Simplified Excitation System Model - SEXS in PSSE","struct_name":"SEXS","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage Measurement Time Constant in s","valid_range":{"max":0.5,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Amplifier Gain","valid_range":{"max":500,"min":10}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Amplifier Time Constant in s","valid_range":{"max":1,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Tc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Voltage regulator limits (regulator output) (Vi_min, Vi_max)"},{"name":"Ke","data_type":"Float64","null_value":0,"comment":"Exciter constant related to self-excited field","valid_range":{"max":null,"min":0}},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Exciter time constant, integration rate associated with exciter control","valid_range":{"max":1,"min":"eps()"}},{"name":"Kf","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Excitation control system stabilizer gain","valid_range":{"max":0.3,"min":"eps()"}},{"name":"Tf","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Excitation control system stabilizer time constant","valid_range":{"max":null,"min":"eps()"}},{"name":"switch","data_type":"Int","null_value":0,"validation_action":"error","comment":"Switch","valid_range":{"max":1,"min":0}},{"name":"E_sat","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter output voltage for saturation factor: (E1, E2)"},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter saturation factor at exciter output voltage: (Se(E1), Se(E2))"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"saturation_coeffs","default":"PowerSystems.get_avr_saturation(E_sat, Se)","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Coefficients (A,B) of the function: Se(V) = B(V - A)^2/V"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVt: Terminal Voltage,\n\tVr1: input lead lag,\n\tVr2: Regulator Output,\n\tVf: Exciter Output, \n\tVr3: Rate feedback integrator","internal_default":"[:Vt, :Vr1, :Vr2, :Vf, :Vr3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The ESDC1A has 5 states","internal_default":5},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"ESDC1A has 5 differential states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Self-excited shunt fields with the voltage regulator operating in a mode commonly termed buck-boost. \nParameters of IEEE Std 421.5 Type DC1A Excitacion System. This model corresponds to ESDC1A in PSSE and PSLF","struct_name":"ESDC1A","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage Measurement Time Constant in s","valid_range":{"max":0.5,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Amplifier Gain","valid_range":{"max":500,"min":10}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Amplifier Time Constant in s","valid_range":{"max":1,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Tc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Voltage regulator limits (regulator output) (Vi_min, Vi_max)"},{"name":"Ke","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter constant related to self-excited field","valid_range":{"max":1,"min":-1}},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Exciter time constant, integration rate associated with exciter control","valid_range":{"max":2,"min":"eps()"}},{"name":"Kf","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Excitation control system stabilizer gain","valid_range":{"max":0.3,"min":0}},{"name":"Tf","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Excitation control system stabilizer time constant. Appropiate Data: 5.0 <= Tf/Kf <= 15.0","valid_range":{"max":1.5,"min":"eps()"}},{"name":"switch","data_type":"Int","null_value":0,"validation_action":"error","comment":"Switch","valid_range":{"max":1,"min":0}},{"name":"E_sat","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter output voltage for saturation factor: (E1, E2)"},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter saturation factor at exciter output voltage: (Se(E1), Se(E2))"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"saturation_coeffs","default":"PowerSystems.get_avr_saturation(E_sat, Se)","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Coefficients (A,B) of the function: Se(V) = B(V - A)^2/V"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVt: Terminal Voltage,\n\tVr1: input lead lag,\n\tVr2: Regulator Output,\n\tVf: Exciter Output, \n\tVr3: Rate feedback integrator","internal_default":"[:Vt, :Vr1, :Vr2, :Vf, :Vr3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The ESDC2A has 5 states","internal_default":5},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"ESDC2A has 5 differential states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Is used to represent field-controlled dc commutator exciters with continuously acting voltage regulators having power supplies derived from the generator or auxiliaries bus.\nParameters of IEEE Std 421.5 Type DC2A Excitacion System. This model corresponds to ESDC2A in PSSE and PSLF","struct_name":"ESDC2A","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage Measurement Time Constant in s","valid_range":{"max":0.5,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Amplifier Gain","valid_range":{"max":500,"min":10}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Amplifier Time Constant in s","valid_range":{"max":1,"min":0}},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Voltage regulator limits (regulator output) (Vi_min, Vi_max)"},{"name":"Ke","data_type":"Float64","null_value":0,"comment":"Exciter constant related to self-excited field","valid_range":{"max":1,"min":-1}},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Exciter time constant, integration rate associated with exciter control","valid_range":{"max":1,"min":"eps()"}},{"name":"Kf","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Excitation control system stabilizer gain","valid_range":{"max":0.3,"min":"eps()"}},{"name":"Tf","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Excitation control system stabilizer time constant. Appropiate Data: 5 <= Tf/Kf <= 15","valid_range":{"max":null,"min":"eps()"}},{"name":"switch","data_type":"Int","null_value":0,"validation_action":"error","comment":"Switch","valid_range":{"max":1,"min":0}},{"name":"E_sat","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter output voltage for saturation factor: (E1, E2)"},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter saturation factor at exciter output voltage: (Se(E1), Se(E2))"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"saturation_coeffs","default":"PowerSystems.get_avr_saturation(E_sat, Se)","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Coefficients (A,B) of the function: Se(V) = B(V - A)^2/V"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVt: Terminal Voltage,\n\tVr: Regulator Output,\n\tVf: Exciter Output, \n\tVr3: Rate feedback integrator","internal_default":"[:Vt, :Vr1, :Vf, :Vr2]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The IEEET1 has 4 states","internal_default":4},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"IEEET1 I has 4 differential states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"1968 IEEE type 1 excitation system model","struct_name":"IEEET1","supertype":"AVR"},{"fields":[{"name":"Ka","data_type":"Float64","null_value":0,"comment":"Amplifier Gain","valid_range":{"max":null,"min":0}},{"name":"Ke","data_type":"Float64","null_value":0,"comment":"Field circuit integral deviation","valid_range":{"max":null,"min":0}},{"name":"Kf","data_type":"Float64","null_value":0,"comment":"Stabilizer Gain in s * pu/pu","valid_range":{"max":null,"min":0}},{"name":"Ta","data_type":"Float64","null_value":0,"comment":"Amplifier Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Te","data_type":"Float64","null_value":0,"comment":"Field Circuit Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Tf","data_type":"Float64","null_value":0,"comment":"Stabilizer Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Tr","data_type":"Float64","null_value":0,"comment":"Voltage Measurement Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Va_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for pi controler `(Va_min, Va_max)`"},{"name":"Ae","data_type":"Float64","null_value":0,"comment":"1st ceiling coefficient","valid_range":{"max":null,"min":0}},{"name":"Be","data_type":"Float64","null_value":0,"comment":"2nd ceiling coefficient","valid_range":{"max":null,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVf: Voltage field,\n\tVr1: Amplifier State,\n\tVr2: Stabilizing Feedback State,\n\tVm: Measured voltage","internal_default":"[:Vf, :Vr1, :Vr2, :Vm]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The AVR Type I has 4 states","internal_default":4},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"AVR Type I has 4 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of an Automatic Voltage Regulator Type I - Resembles IEEE Type DC1","struct_name":"AVRTypeI","supertype":"AVR"},{"fields":[{"name":"K0","data_type":"Float64","null_value":0,"comment":"Regulator Gain","valid_range":{"max":null,"min":0}},{"name":"T1","data_type":"Float64","null_value":0,"comment":"First Pole in s","valid_range":{"max":null,"min":0}},{"name":"T2","data_type":"Float64","null_value":0,"comment":"First zero in s","valid_range":{"max":null,"min":0}},{"name":"T3","data_type":"Float64","null_value":0,"comment":"First Pole in s","valid_range":{"max":null,"min":0}},{"name":"T4","data_type":"Float64","null_value":0,"comment":"First zero in s","valid_range":{"max":null,"min":0}},{"name":"Te","data_type":"Float64","null_value":0,"comment":"Field Circuit Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Tr","data_type":"Float64","null_value":0,"comment":"Voltage Measurement Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Va_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for pi controler `(Va_min, Va_max)`"},{"name":"Ae","data_type":"Float64","null_value":0,"comment":"1st ceiling coefficient","valid_range":{"max":null,"min":0}},{"name":"Be","data_type":"Float64","null_value":0,"comment":"2nd ceiling coefficient","valid_range":{"max":null,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVf: Voltage field,\n\tVr1: First Lead-Lag state,\n\tVr2: Second lead-lag state,\n\tVm: Measured voltage","internal_default":"[:Vf, :Vr1, :Vr2, :Vm]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"AVR Type II has 4 states","internal_default":4},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"AVR Type II has 4 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of an Automatic Voltage Regulator Type II - Typical static exciter model","struct_name":"AVRTypeII","supertype":"AVR"},{"fields":[{"name":"Ta_Tb","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Lead input constant ratio","valid_range":{"max":0.3,"min":0.05}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Lag input constant in s","valid_range":{"max":20,"min":5}},{"name":"K","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator Gain","valid_range":{"max":100,"min":20}},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator Time Constant","valid_range":{"max":1,"min":0}},{"name":"Efd_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Field Voltage regulator limits (regulator output) (Efd_min, Efd_max)"},{"name":"switch","data_type":"Int","null_value":0,"validation_action":"error","comment":"Switch","valid_range":{"max":1,"min":0}},{"name":"rc_rfd","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Field current capability. Set = 0 for negative current capability. Typical value 10","valid_range":{"max":10,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVr1: First integrator,\n\tVr2: Second integrator","internal_default":"[:Vr1, :Vr2]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"SCRX has 2 states","internal_default":2},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"SCRX has 2 differential states","internal_default":"[StateTypes.Differential, StateTypes.Hybrid]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"This exciter is based on an IEEE type SCRX solid state exciter. The output field voltage is varied by a control system to maintain the system voltage at Vref. Please note that this exciter model has no initialization capabilities - this means that it will respond to whatever inputs it receives regardless of the state of the machine model.","struct_name":"SCRX","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input filter time constant in s","valid_range":{"max":0.5,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator denominator (lag) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Tc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator numerator (lead) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator output gain","valid_range":{"max":1000,"min":0}},{"name":"Ta","data_type":"Float64","null_value":0,"comment":"Regulator output time constant in s","valid_range":{"max":10,"min":0}},{"name":"Va_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for regulator output `(Va_min, Va_max)`"},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Exciter field time constant in s","valid_range":{"max":2,"min":"eps()"}},{"name":"Kf","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rate feedback excitation system stabilizer gain","valid_range":{"max":0.3,"min":0}},{"name":"Tf","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Rate feedback time constant","valid_range":{"max":1.5,"min":"eps()"}},{"name":"Kc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rectifier loading factor proportional to commutating reactance","valid_range":{"max":1,"min":0}},{"name":"Kd","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Demagnetizing factor, function of exciter alternator reactances","valid_range":{"max":1,"min":0}},{"name":"Ke","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter field proportional constant","valid_range":{"max":1,"min":0}},{"name":"E_sat","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter output voltage for saturation factor: (E1, E2)"},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter saturation factor at exciter output voltage: (Se(E1), Se(E2))"},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for exciter field voltage: `(Vr_min, Vr_max)`"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"saturation_coeffs","default":"PowerSystems.get_avr_saturation(E_sat, Se)","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Coefficients (A,B) of the function: Se(x) = B(x - A)^2/x"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVm: Sensed terminal voltage,\n\tVr1: Lead-lag state,\n\tVr2: Regulator output state,\n\tVe: Integrator output state,\n\tVr3: Feedback output state","internal_default":"[:Vm, :Vr1, :Vr2, :Ve, :Vr3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ESAC1A has 5 states","internal_default":5},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"ESAC1A has 5 states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"This excitation systems consists of an alternator main exciter feeding its output via non-controlled rectifiers.\nThe exciter does not employ self-excitation, and the voltage regulator power is taken from a source that is not affected by external transients.\nParameters of IEEE Std 421.5 Type AC1A Excitacion System. This model corresponds to ESAC1A in PSSE and PSLF","struct_name":"ESAC1A","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input filter time constant in s","valid_range":{"max":0.5,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator denominator (lag) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Tc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator numerator (lead) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator output gain","valid_range":{"max":1000,"min":0}},{"name":"Ta","data_type":"Float64","null_value":0,"comment":"Regulator output time constant in s","valid_range":{"max":10,"min":0}},{"name":"Va_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for regulator output `(Va_min, Va_max)`"},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Exciter field time constant in s","valid_range":{"max":2,"min":"eps()"}},{"name":"Kf","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rate feedback excitation system stabilizer gain","valid_range":{"max":0.3,"min":0}},{"name":"Tf","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Rate feedback time constant","valid_range":{"max":1.5,"min":"eps()"}},{"name":"Kc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rectifier loading factor proportional to commutating reactance","valid_range":{"max":1,"min":0}},{"name":"Kd","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Demagnetizing factor, function of exciter alternator reactances","valid_range":{"max":1,"min":0}},{"name":"Ke","data_type":"Float64","null_value":0,"comment":"Exciter field proportional constant","valid_range":{"max":1,"min":0}},{"name":"E_sat","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter output voltage for saturation factor: (E1, E2)"},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter saturation factor at exciter output voltage: (Se(E1), Se(E2))"},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for exciter field voltage: `(Vr_min, Vr_max)`"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"saturation_coeffs","default":"PowerSystems.get_avr_saturation(E_sat, Se)","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Coefficients (A,B) of the function: Se(x) = B(x - A)^2/x"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVm: Sensed terminal voltage,\n\tVr1: Lead-lag state,\n\tVr2: Regulator output state,\n\tVe: Integrator output state,\n\tVr3: Feedback output state","internal_default":"[:Vm, :Vr1, :Vr2, :Ve, :Vr3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"EXAC1A has 5 states","internal_default":5},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"EXAC1A has 5 states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Modified ESAC1A. This excitation systems consists of an alternator main exciter feeding its output via non-controlled rectifiers.\nThe exciter does not employ self-excitation, and the voltage regulator power is taken from a source that is not affected by external transients.\nParameters of IEEE Std 421.5 Type AC1A Excitacion System. EXAC1A in PSSE and PSLF","struct_name":"EXAC1A","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input filter time constant in s","valid_range":{"max":0.5,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator denominator (lag) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Tc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator numerator (lead) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"comment":"Regulator output gain","valid_range":{"max":1000,"min":0}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator output time constant in s","valid_range":{"max":10,"min":0}},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for regulator output `(Vr_min, Vr_max)`"},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Exciter field time constant in s","valid_range":{"max":2,"min":"eps()"}},{"name":"Kf","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rate feedback excitation system stabilizer gain","valid_range":{"max":0.3,"min":0}},{"name":"Tf","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Rate feedback time constant","valid_range":{"max":1.5,"min":"eps()"}},{"name":"Kc","data_type":"Float64","null_value":0,"comment":"Rectifier loading factor proportional to commutating reactance","valid_range":{"max":1,"min":0}},{"name":"Kd","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Demagnetizing factor, function of exciter alternator reactances","valid_range":{"max":1,"min":0}},{"name":"Ke","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter field proportional constant","valid_range":{"max":1,"min":0}},{"name":"E_sat","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter output voltage for saturation factor: (E1, E2)"},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter saturation factor at exciter output voltage: (Se(E1), Se(E2))"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"saturation_coeffs","default":"PowerSystems.get_avr_saturation(E_sat, Se)","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Coefficients (A,B) of the function: Se(V) = B(V - A)^2/V"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVm: Sensed terminal voltage,\n\tVr1: Lead-lag state,\n\tVr2: Regulator output state,\n\tVe: Integrator output state,\n\tVr3: Feedback output state","internal_default":"[:Vm, :Vr1, :Vr2, :Ve, :Vr3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"EXAC1 has 5 states","internal_default":5},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"EXAC1 has 5 states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Modified ESAC1A. This excitation systems consists of an alternator main exciter feeding its output via non-controlled rectifiers.\nThe exciter does not employ self-excitation, and the voltage regulator power is taken from a source that is not affected by external transients.\nParameters of IEEE Std 421.5 Type AC1A. EXAC1 in PSSE and PSLF","struct_name":"EXAC1","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input filter time constant in s","valid_range":{"max":0.5,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator denominator (lag) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Tc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator numerator (lead) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"comment":"Regulator output gain","valid_range":{"max":1000,"min":0}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator output time constant in s","valid_range":{"max":10,"min":0}},{"name":"Va_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for regulator output `(Va_min, Va_max)`"},{"name":"Kb","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Second Stage regulator gain","valid_range":{"max":500,"min":"eps()"}},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for exciter field voltage `(Vr_min, Vr_max)`"},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Exciter field time constant","valid_range":{"max":2,"min":"eps()"}},{"name":"Kl","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter field current limiter gain","valid_range":{"max":1.1,"min":0}},{"name":"Kh","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter field current regulator feedback gain","valid_range":{"max":1.1,"min":0}},{"name":"Kf","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rate feedback excitation system stabilizer gain","valid_range":{"max":0.3,"min":0}},{"name":"Tf","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Rate feedback time constant","valid_range":{"max":null,"min":"eps()"}},{"name":"Kc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rectifier loading factor proportional to commutating reactance","valid_range":{"max":1,"min":0}},{"name":"Kd","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Demagnetizing factor, function of exciter alternator reactances","valid_range":{"max":1,"min":0}},{"name":"Ke","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter field proportional constant","valid_range":{"max":1,"min":0}},{"name":"V_lr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Maximum exciter field current","valid_range":{"max":null,"min":0}},{"name":"E_sat","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter output voltage for saturation factor: (E1, E2)"},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter saturation factor at exciter output voltage: (Se(E1), Se(E2))"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"saturation_coeffs","default":"PowerSystems.get_avr_saturation(E_sat, Se)","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Coefficients (A,B) of the function: Se(V) = B(V - A)^2/V"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVm: Sensed terminal voltage,\n\tVr1: Lead-lag state,\n\tVr2: Regulator output state,\n\tVe: Integrator output state,\n\tVr3: Feedback output state","internal_default":"[:Vm, :Vr1, :Vr2, :Ve, :Vr3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"EXAC2 has 5 states","internal_default":5},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"EXAC2 has 5 states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Modified AC2. This excitation systems consists of an alternator main exciter feeding its output via non-controlled rectifiers.\nThe exciter does not employ self-excitation, and the voltage regulator power is taken from a source that is not affected by external transients.\nParameters of IEEE Std 421.5 Type AC2A Excitacion System. The alternator main exciter is used, feeding its output via non-controlled rectifiers. The Type AC2C model is similar to that of Type AC1C except for the inclusion of exciter time constant compensation and exciter field current limiting elements. EXAC2 in PSSE and PSLF.","struct_name":"EXAC2","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input filter time constant in s","valid_range":{"max":0.5,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator output gain","valid_range":{"max":1000,"min":0}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator output lag time constant in s","valid_range":{"max":10,"min":0}},{"name":"Tk","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage Regulator lead time constant","valid_range":{"max":10,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator denominator (lag) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Tc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator numerator (lead) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Va_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for regulator output `(Va_min, Va_max)`"},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for exciter field voltage `(Vr_min, Vr_max)`"},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Exciter field time constant","valid_range":{"max":2,"min":"eps()"}},{"name":"VFE_lim","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter field current limiter reference","valid_range":{"max":20,"min":-5}},{"name":"Kh","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter field current regulator feedback gain","valid_range":{"max":100,"min":0}},{"name":"VH_max","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter field current limiter maximum output","valid_range":{"max":100,"min":0}},{"name":"Th","data_type":"Float64","null_value":0,"comment":"Exciter field current limiter denominator (lag) time constant","valid_range":{"max":1,"min":0}},{"name":"Tj","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter field current limiter numerator (lead) time constant","valid_range":{"max":1,"min":0}},{"name":"Kc","data_type":"Float64","null_value":0,"comment":"Rectifier loading factor proportional to commutating reactance","valid_range":{"max":1,"min":0}},{"name":"Kd","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Demagnetizing factor, function of exciter alternator reactances","valid_range":{"max":2,"min":0}},{"name":"Ke","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter field proportional constant","valid_range":{"max":2,"min":0}},{"name":"E_sat","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter output voltage for saturation factor: (E1, E2)"},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter saturation factor at exciter output voltage: (Se(E1), Se(E2))"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"saturation_coeffs","default":"PowerSystems.get_avr_saturation(E_sat, Se)","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Coefficients (A,B) of the function: Se(V) = B(V - A)^2/V"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVm: Sensed terminal voltage,\n\tVr1: Lead-lag state,\n\tVr2: Regulator output state,\n\tVe: Integrator output state,\n\tVr3: Feedback output state","internal_default":"[:Vm, :Vr1, :Vr2, :Ve, :Vr3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ESAC6A has 5 states","internal_default":5},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"ESAC6A has 5 states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential, StateTypes.Hybrid]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Modified AC6A. Used to represent field-controlled alternator-rectifier excitation systems with system-supplied electronic voltage regulators. \nParameters of IEEE Std 421.5 Type AC6A Excitacion System. ESAC6A in PSSE and PSLF.","struct_name":"ESAC6A","supertype":"AVR"},{"fields":[{"name":"UEL_flags","data_type":"Int","null_value":1,"validation_action":"warn","comment":"Code input for Underexcitization limiter (UEL) entry. Not supported.","valid_range":{"max":3,"min":1}},{"name":"PSS_flags","data_type":"Int","null_value":1,"comment":"Code input for Power System Stabilizer (PSS) or (VOS) entry.","valid_range":{"max":2,"min":1}},{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input filter time constant in s","valid_range":{"max":0.1,"min":0}},{"name":"Vi_lim","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Voltage error limits (regulator input) (Vi_min, Vi_max)"},{"name":"Tc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"First regulator denominator (lead) time constant in s","valid_range":{"max":10,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"comment":"First regulator denominator (lag) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Tc1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Second regulator denominator (lead) time constant in s","valid_range":{"max":10,"min":0}},{"name":"Tb1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Second regulator denominator (lead) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage regulator gain","valid_range":{"max":1000,"min":50}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage regulator time constant in s","valid_range":{"max":0.5,"min":0}},{"name":"Va_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for regulator output `(Va_min, Va_max)`"},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for exciter output `(Vr_min, Vr_max)`"},{"name":"Kc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rectifier loading factor proportional to commutating reactance","valid_range":{"max":0.3,"min":0}},{"name":"Kf","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rate feedback gain","valid_range":{"max":0.3,"min":0}},{"name":"Tf","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Rate feedback time constant in s","valid_range":{"max":1.5,"min":"eps()"}},{"name":"K_lr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter output current limiter gain","valid_range":{"max":5,"min":0}},{"name":"I_lr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter output current limit reference","valid_range":{"max":5,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVm: Sensed terminal voltage,\n\tVr1: First Lead-lag state,\n\tVr2: Second lead-lag state,\n\tVa: Regulator output state,\n\tVr3: Feedback output state","internal_default":"[:Vm, :Vr1, :Vr2, :Va, :Vr3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ST1A has 5 states","internal_default":5},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"ST1A has 5 states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"This excitation system supplies power through a transformer from the generator terminals and its regulated by a controlled rectifier (via thyristors).\nParameters of IEEE Std 421.5 Type ST1A Excitacion System. ESST1A in PSSE and PSLF","struct_name":"ESST1A","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input filter time constant in s","valid_range":{"max":0.5,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage regulator gain","valid_range":{"max":500,"min":1}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage regulator time constant in s","valid_range":{"max":10,"min":0}},{"name":"Va_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for pi controler `(Vr_min, Vr_max)`"},{"name":"Ta_2","data_type":"Float64","null_value":0,"comment":"Voltage regulator time constant in s","valid_range":{"max":null,"min":0}},{"name":"Ta_3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage regulator time constant in s","valid_range":{"max":null,"min":0}},{"name":"Ta_4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage regulator time constant in s","valid_range":{"max":null,"min":0}},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Voltage regulator limits (regulator output) (Vi_min, Vi_max)"},{"name":"Kf","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rate feedback gain","valid_range":{"max":0.3,"min":0}},{"name":"Tf_1","validation_actions":"error","data_type":"Float64","null_value":0,"comment":"Rate Feedback time constant in s","valid_range":{"max":15,"min":"eps()"}},{"name":"Tf_2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rate Feedback time constant in s","valid_range":{"max":5,"min":0}},{"name":"Efd_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Field Voltage regulator limits (regulator output) (Efd_min, Efd_max)"},{"name":"Ke","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter constant","valid_range":{"max":1,"min":0}},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter time constant","valid_range":{"max":2,"min":0}},{"name":"E_sat","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter output voltage for saturation factor: (E1, E2)"},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter saturation factor at exciter output voltage: (Se(E1), Se(E2))"},{"name":"Kp","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Potential source gain","valid_range":{"max":5,"min":0}},{"name":"Ki","data_type":"Float64","null_value":0,"comment":"current source gain","valid_range":{"max":1.1,"min":0}},{"name":"Kc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter regulation factor","valid_range":{"max":2,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"saturation_coeffs","default":"PowerSystems.get_avr_saturation(E_sat, Se)","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Coefficients (A,B) of the function: Se(V) = B(V - A)^2/V"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVm: Sensed terminal voltage,\n\tVr1: First Lead-lag state,\n\tVr2: Second regulator lead-lag state,\n\tVr2: Third regulator lead-lag state \n\tVf: Exciter output \n\tVr3: First feedback integrator,\n\tVr4: second feedback integrator","internal_default":"[:Vm, :Vr1, :Vr2, :Vf, :Vr3, :Vr4]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"EXPIC1 has 6 states","internal_default":6},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"EXPIC has 6 states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential, StateTypes.Hybrid]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Generic Proportional/Integral Excitation System","struct_name":"EXPIC1","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input filter time constant in s","valid_range":{"max":0.5,"min":0}},{"name":"K_pr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator propotional gain","valid_range":{"max":75,"min":0}},{"name":"K_ir","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator integral gain","valid_range":{"max":75,"min":0}},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Voltage regulator limits (Vi_min, Vi_max)"},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage regulator time constant in s","valid_range":{"max":1,"min":0}},{"name":"K_pm","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage regulator proportional gain output","valid_range":{"max":1.2,"min":0}},{"name":"K_im","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage regulator integral gain output","valid_range":{"max":18,"min":0}},{"name":"Vm_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for inner loop output `(Vm_min, Vm_max)`"},{"name":"Kg","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Feedback gain constant of the inner loop field regulator","valid_range":{"max":1.1,"min":0}},{"name":"Kp","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Potential circuit (voltage) gain coefficient","valid_range":{"max":10,"min":0}},{"name":"Ki","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Compound circuit (current) gain coefficient","valid_range":{"max":1.1,"min":0}},{"name":"VB_max","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Maximum available exciter voltage","valid_range":{"max":20,"min":1}},{"name":"Kc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rectifier loading factor proportional to commutating reactance","valid_range":{"max":1,"min":0}},{"name":"Xl","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Reactance associated with potential source","valid_range":{"max":0.5,"min":0}},{"name":"θp","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Potential circuit phase angle (degrees)","valid_range":{"max":90,"min":-90}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"θp_rad","default":"θp*π*inv(180)","data_type":"Float64","null_value":0,"comment":"Potential circuit phase angle (radians)"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVm: Sensed terminal voltage,\n\tVt: Sensed Terminal Voltage,\n\tVr1: Regulator Integrator,\n\tVr2: Regulator Output,\n\tVm: Output integrator","internal_default":"[:Vt, :Vr1, :Vr2, :Vm]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ST4B has 4 states","internal_default":4},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"ST4B has 4 states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"In these excitation systems, voltage (and also current in compounded systems) is transformed to an appropriate level. Rectifiers, either controlled or non-controlled, provide the necessary direct current for the generator field.\nParameters of IEEE Std 421.5 Type ST4B Excitacion System. ESST4B in PSSE and PSLF","struct_name":"ESST4B","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage Measurement Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Vi_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Voltage input limits (Vi_min, Vi_max)"},{"name":"Tc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Numerator lead-lag (lead) time constant in s","valid_range":{"max":null,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Denominator lead-lag (lag) time constant in s","valid_range":{"max":null,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Amplifier Gain","valid_range":{"max":null,"min":0}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Amplifier Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Voltage regulator limits (regulator output) (Vr_min, Vr_max)"},{"name":"Kc","data_type":"Float64","null_value":0,"comment":"Current field constant limiter multiplier","valid_range":{"max":null,"min":0}},{"name":"Kf","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Excitation control system stabilizer gain","valid_range":{"max":0.3,"min":"eps()"}},{"name":"Tf","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Excitation control system stabilizer time constant","valid_range":{"max":null,"min":"eps()"}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVm: Sensed Terminal Voltage,\n\tVrll: Lead-Lag state,\n\tVr: Regulator Output, \n\tVfb: Feedback state","internal_default":"[:Vm, :Vrll, :Vr, :Vfb]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The EXST1 has 4 states","internal_default":4},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"IEEE Type ST1 Excitation System (PTI version)","struct_name":"EXST1","supertype":"AVR"},{"fields":[{"name":"Iflim","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"OEL Field current limit","valid_range":{"max":null,"min":0}},{"name":"d","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"OEL parameter d","valid_range":{"max":null,"min":0}},{"name":"f","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"OEL parameter f","valid_range":{"max":null,"min":0}},{"name":"Spar","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"OEL parameter Spar","valid_range":{"max":null,"min":0}},{"name":"K1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"OEL delay time constant","valid_range":{"max":null,"min":0}},{"name":"K2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"OEL parameter K2","valid_range":{"max":null,"min":0}},{"name":"Oel_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Oel integrator limits (Oel_min, Oel_max)"},{"name":"G","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"AVR Exciter Gain","valid_range":{"max":null,"min":0}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Numerator lead-lag (lag) time constant in s","valid_range":{"max":null,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Denominator lead-lag (lag) time constant in s","valid_range":{"max":null,"min":0}},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"E_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Voltage regulator limits (regulator output) (E_min, E_max)"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVll: Lead-lag internal state,\n\tVex: Exciter Output, \n\toel: OEL integrator state","internal_default":"[:Vll, :Vex, :oel]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The EX4VSA has 3 states","internal_default":3},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"IEEE Excitation System for Voltage Security Assesment","struct_name":"EX4VSA","supertype":"AVR"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Resistance after EMF in machine per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_p","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in machine per unit","valid_range":{"max":null,"min":0}},{"name":"eq_p","data_type":"Float64","null_value":0,"comment":"Fixed EMF behind the impedance","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"BaseMachine has no states","internal_default":"Vector{Symbol}()"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"BaseMachine has no states","internal_default":0},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of a Classic Machine: GENCLS in PSSE and PSLF","struct_name":"BaseMachine","supertype":"Machine"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Armature resistance","valid_range":{"max":null,"min":0}},{"name":"Td0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Td0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Xd","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in d-axis per unit. Note: Xd_pp = Xq_pp","valid_range":{"max":null,"min":0}},{"name":"Xl","data_type":"Float64","null_value":0,"comment":"Stator leakage reactance","valid_range":{"max":null,"min":0}},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Saturation factor at 1 and 1.2 pu flux: S(1.0) = B(|ψ_pp|-A)^2"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"γ_d1","data_type":"Float64","comment":"γ_d1 parameter","internal_default":"(Xd_pp - Xl) / (Xd_p - Xl)"},{"name":"γ_q1","data_type":"Float64","comment":"γ_q1 parameter","internal_default":"(Xd_pp - Xl) / (Xq_p - Xl)"},{"name":"γ_d2","data_type":"Float64","comment":"γ_d2 parameter","internal_default":"(Xd_p - Xd_pp) / (Xd_p - Xl)^2"},{"name":"γ_q2","data_type":"Float64","comment":"γ_q2 parameter","internal_default":"(Xq_p - Xd_pp) / (Xq_p - Xl)^2"},{"name":"γ_qd","data_type":"Float64","comment":"γ_qd parameter","internal_default":"(Xq - Xl) / (Xd - Xl)"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\teq_p: q-axis generator voltage behind the transient reactance,\n\ted_p: d-axis generator voltage behind the transient reactance,\n\tψ_kd: flux linkage in the first equivalent damping circuit in the d-axis,\n\tψ_kq: flux linkage in the first equivalent damping circuit in the d-axis","internal_default":"[:eq_p, :ed_p, :ψ_kd, :ψ_kq]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"RoundRotorMachine has 4 states","internal_default":4},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 4-states round-rotor synchronous machine with quadratic/exponential saturation:\nIEEE Std 1110 §5.3.2 (Model 2.2). GENROU or GENROE model in PSSE and PSLF.","struct_name":"RoundRotorMachine","supertype":"Machine"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Armature resistance","valid_range":{"max":null,"min":0}},{"name":"Td0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Td0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Xd","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in d-axis per unit. Note: Xd_pp = Xq_pp","valid_range":{"max":null,"min":0}},{"name":"Xl","data_type":"Float64","null_value":0,"comment":"Stator leakage reactance","valid_range":{"max":null,"min":0}},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Saturation factor at 1 and 1.2 pu flux: Se(eq_p) = B(eq_p-A)^2"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"γ_d1","data_type":"Float64","comment":"γ_d1 parameter","internal_default":"(Xd_pp - Xl) / (Xd_p - Xl)"},{"name":"γ_q1","data_type":"Float64","comment":"γ_q1 parameter","internal_default":"(Xd_p - Xd_pp) / (Xd_p - Xl)"},{"name":"γ_d2","data_type":"Float64","comment":"γ_d2 parameter","internal_default":"(Xd_p - Xd_pp) / (Xd_p - Xl)^2"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\teq_p: q-axis generator voltage behind the transient reactance,\n\tψ_kd: flux linkage in the first equivalent damping circuit in the d-axis,\n\tψq_pp: phasonf of the subtransient flux linkage in the q-axis","internal_default":"[:eq_p, :ψ_kd, :ψq_pp]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"SalientPoleMachine has 3 states","internal_default":3},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 3-states salient-pole synchronous machine with quadratic/exponential saturation:\nIEEE Std 1110 §5.3.1 (Model 2.1). GENSAL or GENSAE model in PSSE and PSLF.","struct_name":"SalientPoleMachine","supertype":"Machine"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Resistance after EMF in machine per unit","valid_range":{"max":null,"min":0}},{"name":"Xd","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Td0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Td0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tψq: q-axis stator flux,\n\tψd: d-axis stator flux,\n\teq_p: q-axis transient voltage,\n\ted_p: d-axis transient voltage,\n\teq_pp: q-axis subtransient voltage,\n\ted_pp: d-axis subtransient voltage","internal_default":"[:ψq, :ψd, :eq_p, :ed_p, :eq_pp, :ed_pp]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"AndersonFouadMachine has 6 states","internal_default":6},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 6-states synchronous machine: Anderson-Fouad model","struct_name":"AndersonFouadMachine","supertype":"Machine"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Resistance after EMF in machine per unit","valid_range":{"max":null,"min":0}},{"name":"R_f","data_type":"Float64","null_value":0,"comment":"Field rotor winding resistance in per unit","valid_range":{"max":null,"min":0}},{"name":"R_1d","data_type":"Float64","null_value":0,"comment":" Damping rotor winding resistance on d-axis in per unit. This value is denoted as RD in Machowski.","valid_range":{"max":null,"min":0}},{"name":"R_1q","data_type":"Float64","null_value":0,"comment":"Damping rotor winding resistance on q-axis in per unit. This value is denoted as RQ in Machowski.","valid_range":{"max":null,"min":0}},{"name":"L_d","data_type":"Float64","null_value":1,"comment":"Inductance of fictitious damping that represent the effect of the three-phase stator winding in the d-axis of the rotor, in per unit. This value is denoted as L_ad + L_l in Kundur (and Ld in Machowski).","valid_range":{"max":null,"min":0}},{"name":"L_q","data_type":"Float64","null_value":1,"comment":"Inductance of fictitious damping that represent the effect of the three-phase stator winding in the q-axis of the rotor, in per unit. This value is denoted as L_aq + L_l in Kundur.","valid_range":{"max":null,"min":0}},{"name":"L_ad","data_type":"Float64","null_value":2,"comment":"Mutual inductance between stator winding and rotor field (and damping) winding inductance on d-axis, in per unit","valid_range":{"max":null,"min":0}},{"name":"L_aq","data_type":"Float64","null_value":2,"comment":"Mutual inductance between stator winding and rotor damping winding inductance on q-axis, in per unit","valid_range":{"max":null,"min":0}},{"name":"L_f1d","data_type":"Float64","null_value":1,"comment":"Mutual inductance between rotor field winding and rotor damping winding inductance on d-axis, in per unit","valid_range":{"max":null,"min":0}},{"name":"L_ff","data_type":"Float64","null_value":2,"comment":"Field rotor winding inductance, in per unit","valid_range":{"max":null,"min":0}},{"name":"L_1d","data_type":"Float64","null_value":1,"comment":"Inductance of the d-axis rotor damping circuit, in per unit","valid_range":{"max":null,"min":0}},{"name":"L_1q","data_type":"Float64","null_value":1,"comment":"Inductance of the q-axis rotor damping circuit, in per unit","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"inv_d_fluxlink","data_type":"Array{Float64,2}","comment":"Equations 3.127, 3.130, 3.131 From Kundur","internal_default":"inv([[-L_d L_ad L_ad]; [-L_ad L_ff L_f1d]; [-L_ad L_f1d L_1d]])"},{"name":"inv_q_fluxlink","data_type":"Array{Float64,2}","comment":"Equations 3.128, 3.132 From Kundur","internal_default":"inv([[-L_q L_aq]; [-L_aq L_1q]])"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tψd: d-axis stator flux,\n\tψq: q-axis stator flux,\n\tψf: field rotor flux,\n\tψ1d: d-axis rotor damping flux,\n\tψ1q: q-axis rotor damping flux","internal_default":"[:ψd, :ψq, :ψf, :ψ1d, :ψ1q]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"FullMachine has 5 states","internal_default":5},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameter of a full order flux stator-rotor model without zero sequence flux in the stator.\n The derivative of stator fluxes (ψd and ψq) is NOT neglected. Only one q-axis damping circuit is considered. All parameters are in machine per unit.\n Refer to Chapter 3 of Power System Stability and Control by P. Kundur or Chapter 11 of Power System Dynamics: Stability and Control, by J. Machowski, J. Bialek and J. Bumby, for more details.\n Note that the models are somewhat different (but equivalent) due to the different Park Transformation used in both books.","struct_name":"FullMachine","supertype":"Machine"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Resistance after EMF in machine per unit","valid_range":{"max":null,"min":0}},{"name":"Xd","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xl","data_type":"Float64","null_value":0,"comment":"Stator Leakage Reactance","valid_range":{"max":null,"min":0}},{"name":"Td0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Td0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"γ_d1","data_type":"Float64","comment":"","internal_default":"(Xd_pp-Xl)/(Xd_p-Xl)"},{"name":"γ_q1","data_type":"Float64","comment":"","internal_default":"(Xq_pp-Xl)/(Xq_p-Xl)"},{"name":"γ_d2","data_type":"Float64","comment":"","internal_default":"(Xd_p - Xd_pp) / (Xd_p - Xl)^2"},{"name":"γ_q2","data_type":"Float64","comment":"","internal_default":"(Xq_p - Xq_pp) / (Xq_p - Xl)^2"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tψq: q-axis stator flux,\n\tψd: d-axis stator flux,\n\teq_p: q-axis transient voltage,\n\ted_p: d-axis transient voltage\n\tψd_pp: subtransient flux linkage in the d-axis\n\tψq_pp: subtransient flux linkage in the q-axis","internal_default":"[:ψq, :ψd, :eq_p, :ed_p, :ψd_pp, :ψq_pp]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"SauerPaiMachine has 6 states","internal_default":6},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of synchronous machine: Sauer Pai model","struct_name":"SauerPaiMachine","supertype":"Machine"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Resistance after EMF in machine per unit","valid_range":{"max":null,"min":0}},{"name":"Xd","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Td0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Td0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"T_AA","data_type":"Float64","null_value":0,"comment":"Time constant of d-axis additional leakage","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"γd","data_type":"Float64","comment":"","internal_default":"((Td0_pp*Xd_pp)/(Td0_p*Xd_p) )*(Xd-Xd_p)"},{"name":"γq","data_type":"Float64","comment":"","internal_default":"((Tq0_pp*Xq_pp)/(Tq0_p*Xq_p) )*(Xq-Xq_p)"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tψq: q-axis stator flux,\n\tψd: d-axis stator flux,\n\teq_p: q-axis transient voltage,\n\ted_p: d-axis transient voltage,\n\teq_pp: q-axis subtransient voltage,\n\ted_pp: d-axis subtransient voltage","internal_default":"[:ψq, :ψd, :eq_p, :ed_p, :eq_pp, :ed_pp]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"MarconatoMachine has 6 states","internal_default":6},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 6-states synchronous machine: Marconato model","struct_name":"MarconatoMachine","supertype":"Machine"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Resistance after EMF in machine per unit","valid_range":{"max":null,"min":0}},{"name":"Xd","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Td0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\teq_p: q-axis transient voltage,\n\ted_p: d-axis transient voltage","internal_default":"[:eq_p, :ed_p]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"OneDOneQMachine has 2 states","internal_default":2},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 4-states synchronous machine: Simplified Marconato model\n The derivative of stator fluxes (ψd and ψq) is neglected and ωψd = ψd and\n ωψq = ψq is assumed (i.e. ω=1.0). This is standard when\n transmission network dynamics is neglected.","struct_name":"OneDOneQMachine","supertype":"Machine"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Resistance after EMF in machine per unit","valid_range":{"max":null,"min":0}},{"name":"Xd","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Td0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Td0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\teq_p: q-axis transient voltage,\n\ted_p: d-axis transient voltage,\n\teq_pp: q-axis subtransient voltage,\n\ted_pp: d-axis subtransient voltage","internal_default":"[:eq_p, :ed_p, :eq_pp, :ed_pp]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"SimpleAFMachine has 4 states","internal_default":4},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 4-states simplified Anderson-Fouad (SimpleAFMachine) model.\n The derivative of stator fluxes (ψd and ψq) is neglected and ωψd = ψd and\n ωψq = ψq is assumed (i.e. ω=1.0). This is standard when transmission network\n dynamics is neglected.\n If transmission dynamics is considered use the full order Anderson Fouad model.","struct_name":"SimpleAFMachine","supertype":"Machine"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Resistance after EMF in machine per unit","valid_range":{"max":null,"min":0}},{"name":"R_f","data_type":"Float64","null_value":0,"comment":"Field rotor winding resistance in per unit","valid_range":{"max":null,"min":0}},{"name":"R_1d","data_type":"Float64","null_value":0,"comment":" Damping rotor winding resistance on d-axis in per unit. This value is denoted as RD in Machowski.","valid_range":{"max":null,"min":0}},{"name":"R_1q","data_type":"Float64","null_value":0,"comment":"Damping rotor winding resistance on q-axis in per unit. This value is denoted as RQ in Machowski.","valid_range":{"max":null,"min":0}},{"name":"L_d","data_type":"Float64","null_value":1,"comment":"Inductance of fictitious damping that represent the effect of the three-phase stator winding in the d-axis of the rotor, in per unit. This value is denoted as L_ad + L_l in Kundur (and Ld in Machowski).","valid_range":{"max":null,"min":0}},{"name":"L_q","data_type":"Float64","null_value":1,"comment":"Inductance of fictitious damping that represent the effect of the three-phase stator winding in the q-axis of the rotor, in per unit. This value is denoted as L_aq + L_l in Kundur.","valid_range":{"max":null,"min":0}},{"name":"L_ad","data_type":"Float64","null_value":2,"comment":"Mutual inductance between stator winding and rotor field (and damping) winding inductance on d-axis, in per unit","valid_range":{"max":null,"min":0}},{"name":"L_aq","data_type":"Float64","null_value":1,"comment":"Mutual inductance between stator winding and rotor damping winding inductance on q-axis, in per unit","valid_range":{"max":null,"min":0}},{"name":"L_f1d","data_type":"Float64","null_value":1,"comment":"Mutual inductance between rotor field winding and rotor damping winding inductance on d-axis, in per unit","valid_range":{"max":null,"min":0}},{"name":"L_ff","data_type":"Float64","null_value":2,"comment":"Field rotor winding inductance, in per unit","valid_range":{"max":null,"min":0}},{"name":"L_1d","data_type":"Float64","null_value":1,"comment":"Inductance of the d-axis rotor damping circuit, in per unit","valid_range":{"max":null,"min":0}},{"name":"L_1q","data_type":"Float64","null_value":2,"comment":"Inductance of the q-axis rotor damping circuit, in per unit","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"inv_d_fluxlink","data_type":"Array{Float64,2}","comment":"Equations 3.127, 3.130, 3.131 From Kundur","internal_default":"inv([[-L_d L_ad L_ad]; [-L_ad L_ff L_f1d]; [-L_ad L_f1d L_1d]])"},{"name":"inv_q_fluxlink","data_type":"Array{Float64,2}","comment":"Equations 3.128, 3.132 From Kundur","internal_default":"inv([[-L_q L_aq]; [-L_aq L_1q]])"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tψf: field rotor flux,\n\tψ1d: d-axis rotor damping flux,\n\tψ1q: q-axis rotor damping flux","internal_default":"[:ψf, :ψ1d, :ψ1q]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"SimpleFullMachine has 3 states","internal_default":3},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameter of a full order flux stator-rotor model without zero sequence flux in the stator.\n The derivative of stator fluxes (ψd and ψq) is neglected. This is standard when\n transmission network dynamics is neglected. Only one q-axis damping circuit\n is considered. All per unit are in machine per unit.\n Refer to Chapter 3 of Power System Stability and Control by P. Kundur or Chapter 11 of Power System Dynamics: Stability and Control, by J. Machowski, J. Bialek and J. Bumby, for more details.\n Note that the models are somewhat different (but equivalent) due to the different Park Transformation used in both books.","struct_name":"SimpleFullMachine","supertype":"Machine"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Resistance after EMF in machine per unit","valid_range":{"max":null,"min":0}},{"name":"Xd","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Td0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Td0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"T_AA","data_type":"Float64","null_value":0,"comment":"Time constant of d-axis additional leakage","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"γd","data_type":"Float64","comment":"","internal_default":"((Td0_pp*Xd_pp)/(Td0_p*Xd_p) )*(Xd-Xd_p)"},{"name":"γq","data_type":"Float64","comment":"","internal_default":"((Tq0_pp*Xq_pp)/(Tq0_p*Xq_p) )*(Xq-Xq_p)"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\teq_p: q-axis transient voltage,\n\ted_p: d-axis transient voltage,\n\teq_pp: q-axis subtransient voltage,\n\ted_pp: d-axis subtransient voltage","internal_default":"[:eq_p, :ed_p, :eq_pp, :ed_pp]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"SimpleMarconatoMachine has 4 states","internal_default":4},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 4-states synchronous machine: Simplified Marconato model\n The derivative of stator fluxes (ψd and ψq) is neglected and ωψd = ψd and\n ωψq = ψq is assumed (i.e. ω=1.0). This is standard when transmission network\n dynamics is neglected.","struct_name":"SimpleMarconatoMachine","supertype":"Machine"},{"fields":[{"name":"V_pss","data_type":"Float64","null_value":0,"comment":"Fixed voltage stabilization signal","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"","internal_default":"Vector{Symbol}()"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"PSSFixed has no states","internal_default":0},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of a PSS that returns a fixed voltage to add to the reference for the AVR","struct_name":"PSSFixed","supertype":"PSS"},{"fields":[{"name":"K_ω","data_type":"Float64","null_value":0,"comment":"Proportional gain for frequency","valid_range":{"max":null,"min":0}},{"name":"K_p","data_type":"Float64","null_value":0,"comment":"Proportional gain for active power","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"","internal_default":"Vector{Symbol}()"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"PSSSimple has no states","internal_default":0},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of a PSS that returns a proportional droop voltage to add to the reference for the AVR","struct_name":"PSSSimple","supertype":"PSS"},{"fields":[{"name":"input_code","data_type":"Int","null_value":1,"validation_action":"error","comment":"Code input for stabilizer","valid_range":{"max":6,"min":1}},{"name":"remote_bus_control","data_type":"Int","null_value":0,"comment":"Remote Bus number for control."},{"name":"A1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Filter coefficient","valid_range":{"max":null,"min":0}},{"name":"A2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Filter coefficient","valid_range":{"max":null,"min":0}},{"name":"A3","data_type":"Float64","null_value":0,"comment":"Filter coefficient","valid_range":{"max":null,"min":0}},{"name":"A4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Filter coefficient","valid_range":{"max":null,"min":0}},{"name":"A5","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Filter coefficient","valid_range":{"max":null,"min":0}},{"name":"A6","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Filter coefficient","valid_range":{"max":null,"min":0}},{"name":"T1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant","valid_range":{"max":10,"min":0}},{"name":"T2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant","valid_range":{"max":10,"min":0}},{"name":"T3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant","valid_range":{"max":10,"min":0}},{"name":"T4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant","valid_range":{"max":10,"min":0}},{"name":"T5","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant","valid_range":{"max":10,"min":0}},{"name":"T6","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Time constant","valid_range":{"max":"2.0","min":"eps()"}},{"name":"Ks","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Proportional gain","valid_range":{"max":null,"min":0}},{"name":"Ls_lim","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"PSS output limits for regulator output `(Ls_min, Ls_max)`"},{"name":"Vcu","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Cutoff limiter upper bound","valid_range":{"max":"1.25","min":0}},{"name":"Vcl","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Cutoff limiter lower bound","valid_range":{"max":"1.0","min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tx_p1: 1st filter integration,\n\tx_p2: 2nd filter integration, \n\tx_p3: 3rd filter integration, \n\tx_p4: 4rd filter integration, \n\tx_p5: T1/T2 lead-lag integrator, \n\tx_p6: T3/T4 lead-lag integrator, \n\t:x_p7 last integer,","internal_default":"[:x_p1, :x_p2, :x_p3, :x_p4, :x_p5, :x_p6, :x_p7]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"IEEEST has 7 states","internal_default":7},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"IEEEST has 7 differential states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"IEEE Stabilizing Model PSS. ","struct_name":"IEEEST","supertype":"PSS"},{"fields":[{"name":"KT","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"K/T for washout filter","valid_range":{"max":null,"min":0}},{"name":"T","data_type":"Float64","null_value":0.01,"validation_action":"warn","comment":"Time constant for washout filter","valid_range":{"max":null,"min":0.01}},{"name":"T1T3","data_type":"Float64","null_value":0,"comment":"Time constant division T1/T3","valid_range":{"max":null,"min":0}},{"name":"T3","data_type":"Float64","null_value":0.01,"validation_action":"warn","comment":"Time constant","valid_range":{"max":null,"min":0.01}},{"name":"T2T4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant division T2/T4","valid_range":{"max":null,"min":0}},{"name":"T4","data_type":"Float64","null_value":0.01,"validation_action":"warn","comment":"Time constant","valid_range":{"max":null,"min":0.01}},{"name":"H_lim","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"PSS output limit","valid_range":{"max":0.5,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tx_p1: washout filter,\n\tx_p2: T1/T3 lead-lag block, \n\tx_p3: T2/T4 lead-lag block,","internal_default":"[:x_p1, :x_p2, :x_p3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"STAB1 has 3 states","internal_default":3},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"STAB1 has 3 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Speed-Sensitive Stabilizing Model","struct_name":"STAB1","supertype":"PSS"},{"fields":[{"name":"input_code_1","data_type":"Int","null_value":1,"validation_action":"error","comment":"First Input Code for stabilizer","valid_range":{"max":6,"min":1}},{"name":"remote_bus_control_1","data_type":"Int","null_value":0,"comment":"First Input Remote Bus number for control."},{"name":"input_code_2","data_type":"Int","null_value":1,"validation_action":"error","comment":"Second Input Code for stabilizer","valid_range":{"max":6,"min":1}},{"name":"remote_bus_control_2","data_type":"Int","null_value":0,"comment":"Second Input Remote Bus number for control."},{"name":"M_rtf","data_type":"Int","null_value":0,"validation_action":"error","comment":"M parameter for ramp tracking filter","valid_range":{"max":8,"min":0}},{"name":"N_rtf","data_type":"Int","null_value":0,"validation_action":"error","comment":"N parameter for ramp tracking filter","valid_range":{"max":8,"min":0}},{"name":"Tw1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first washout filter for first input","valid_range":{"max":null,"min":"eps()"}},{"name":"Tw2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second washout filter for first input","valid_range":{"max":null,"min":0}},{"name":"T6","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for low-pass filter for first input","valid_range":{"max":null,"min":0}},{"name":"Tw3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first washout filter for second input","valid_range":{"max":null,"min":"eps()"}},{"name":"Tw4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second washout filter for second input","valid_range":{"max":null,"min":0}},{"name":"T7","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for low-pass filter for second input","valid_range":{"max":null,"min":0}},{"name":"Ks2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Gain for low-pass filter for second input","valid_range":{"max":null,"min":0}},{"name":"Ks3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Gain for second input","valid_range":{"max":null,"min":0}},{"name":"T8","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for ramp tracking filter","valid_range":{"max":null,"min":0}},{"name":"T9","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for ramp tracking filter","valid_range":{"max":null,"min":"eps()"}},{"name":"Ks1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Gain before lead-lag blocks","valid_range":{"max":null,"min":0}},{"name":"T1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second lead-lag block","valid_range":{"max":null,"min":0}},{"name":"Vst_lim","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"PSS output limits `(Vst_min, Vst_max)`"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tx_p1: 1st washout 1st input, \n\tx_p2: 2nd washout 1st input, \n\tx_p3: transducer 1st input, \n\tx_p4: 1st washout 2nd input, \n\tx_p5: 2nd washout 2nd input, \n\tx_p6: transducer 2nd input, \n\tx_p7: ramp tracking filter state 1, \n\tx_p8: ramp tracking filter state 2, \n\tx_p9: ramp tracking filter state 3, \n\tx_p10: ramp tracking filter state 4, \n\tx_p11: ramp tracking filter state 5, \n\tx_p12: ramp tracking filter state 6, \n\tx_p13: ramp tracking filter state 7, \n\tx_p14: ramp tracking filter state 8, \n\tx_p15: 1st lead-lag, \n\tx_p16: 2nd lead-lag,","internal_default":"[:x_p1, :x_p2, :x_p3, :x_p4, :x_p5, :x_p6, :x_p7, :x_p8, :x_p9, :x_p10, :x_p11, :x_p12, :x_p13, :x_p14, :x_p15, :x_p16]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"IEEEST has 16 states","internal_default":16},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"IEEEST has 16 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"IEEE Dual-Input Stabilizer Model","struct_name":"PSS2A","supertype":"PSS"},{"fields":[{"name":"input_code_1","data_type":"Int","null_value":1,"validation_action":"error","comment":"First Input Code for stabilizer","valid_range":{"max":6,"min":1}},{"name":"remote_bus_control_1","data_type":"Int","null_value":0,"comment":"First Input Remote Bus number for control."},{"name":"input_code_2","data_type":"Int","null_value":1,"validation_action":"error","comment":"Second Input Code for stabilizer","valid_range":{"max":6,"min":1}},{"name":"remote_bus_control_2","data_type":"Int","null_value":0,"comment":"Second Input Remote Bus number for control."},{"name":"M_rtf","data_type":"Int","null_value":0,"validation_action":"error","comment":"M parameter for ramp tracking filter","valid_range":{"max":8,"min":0}},{"name":"N_rtf","data_type":"Int","null_value":0,"validation_action":"error","comment":"N parameter for ramp tracking filter","valid_range":{"max":8,"min":0}},{"name":"Tw1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first washout filter for first input","valid_range":{"max":null,"min":"eps()"}},{"name":"Tw2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second washout filter for first input","valid_range":{"max":null,"min":0}},{"name":"T6","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for low-pass filter for first input","valid_range":{"max":null,"min":0}},{"name":"Tw3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first washout filter for second input","valid_range":{"max":null,"min":"eps()"}},{"name":"Tw4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second washout filter for second input","valid_range":{"max":null,"min":0}},{"name":"T7","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for low-pass filter for second input","valid_range":{"max":null,"min":0}},{"name":"Ks2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Gain for low-pass filter for second input","valid_range":{"max":null,"min":0}},{"name":"Ks3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Gain for second input","valid_range":{"max":null,"min":0}},{"name":"T8","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for ramp tracking filter","valid_range":{"max":null,"min":0}},{"name":"T9","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for ramp tracking filter","valid_range":{"max":null,"min":"eps()"}},{"name":"Ks1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Gain before lead-lag blocks","valid_range":{"max":null,"min":0}},{"name":"T1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T10","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for third lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T11","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for third lead-lag block","valid_range":{"max":null,"min":0}},{"name":"Vs1_lim","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"First input limits `(Vs1_min, Vs1_max)`"},{"name":"Vs2_lim","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Second input limits `(Vs2_min, Vs2_max)`"},{"name":"Vst_lim","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"PSS output limits `(Vst_min, Vst_max)`"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tx_p1: 1st washout 1st input, \n\tx_p2: 2nd washout 1st input, \n\tx_p3: transducer 1st input, \n\tx_p4: 1st washout 2nd input, \n\tx_p5: 2nd washout 2nd input, \n\tx_p6: transducer 2nd input, \n\tx_p7: ramp tracking filter state 1, \n\tx_p8: ramp tracking filter state 2, \n\tx_p9: ramp tracking filter state 3, \n\tx_p10: ramp tracking filter state 4, \n\tx_p11: ramp tracking filter state 5, \n\tx_p12: ramp tracking filter state 6, \n\tx_p13: ramp tracking filter state 7, \n\tx_p14: ramp tracking filter state 8, \n\tx_p15: 1st lead-lag, \n\tx_p16: 2nd lead-lag, \n\tx_p17: 3rd lead-lag,","internal_default":"[:x_p1, :x_p2, :x_p3, :x_p4, :x_p5, :x_p6, :x_p7, :x_p8, :x_p9, :x_p10, :x_p11, :x_p12, :x_p13, :x_p14, :x_p15, :x_p16, :x_p17]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"IEEEST has 17 states","internal_default":17},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"IEEEST has 17 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"IEEE 421.5 2005 PSS2B IEEE Dual-Input Stabilizer Model","struct_name":"PSS2B","supertype":"PSS"},{"fields":[{"name":"input_code_1","data_type":"Int","null_value":1,"validation_action":"error","comment":"First Input Code for stabilizer","valid_range":{"max":7,"min":1}},{"name":"remote_bus_control_1","data_type":"Int","null_value":0,"comment":"First Input Remote Bus number for control."},{"name":"input_code_2","data_type":"Int","null_value":1,"validation_action":"error","comment":"Second Input Code for stabilizer","valid_range":{"max":6,"min":1}},{"name":"remote_bus_control_2","data_type":"Int","null_value":0,"comment":"Second Input Remote Bus number for control."},{"name":"M_rtf","data_type":"Int","null_value":0,"validation_action":"error","comment":"M parameter for ramp tracking filter","valid_range":{"max":8,"min":0}},{"name":"N_rtf","data_type":"Int","null_value":0,"validation_action":"error","comment":"N parameter for ramp tracking filter","valid_range":{"max":8,"min":0}},{"name":"Tw1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first washout filter for first input","valid_range":{"max":null,"min":"eps()"}},{"name":"Tw2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second washout filter for first input","valid_range":{"max":null,"min":0}},{"name":"T6","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for low-pass filter for first input","valid_range":{"max":null,"min":0}},{"name":"Tw3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first washout filter for second input","valid_range":{"max":null,"min":"eps()"}},{"name":"Tw4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second washout filter for second input","valid_range":{"max":null,"min":0}},{"name":"T7","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for low-pass filter for second input","valid_range":{"max":null,"min":0}},{"name":"Ks2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Gain for low-pass filter for second input","valid_range":{"max":null,"min":0}},{"name":"Ks3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Gain for second input","valid_range":{"max":null,"min":0}},{"name":"T8","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for ramp tracking filter","valid_range":{"max":null,"min":0}},{"name":"T9","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for ramp tracking filter","valid_range":{"max":null,"min":"eps()"}},{"name":"Ks1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Gain before lead-lag blocks","valid_range":{"max":null,"min":0}},{"name":"T1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T10","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for third lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T11","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for third lead-lag block","valid_range":{"max":null,"min":0}},{"name":"Vs1_lim","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"First input limits `(Vs1_min, Vs1_max)`"},{"name":"Vs2_lim","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Second input limits `(Vs2_min, Vs2_max)`"},{"name":"Vst_lim","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"PSS output limits `(Vst_min, Vst_max)`"},{"name":"T12","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for fourth lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T13","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for fourth lead-lag block","valid_range":{"max":null,"min":0}},{"name":"PSS_Hysteresis_param","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"PSS output hysteresis parameters `(PSSOFF, PSSON)`"},{"name":"Xcomp","data_type":"Float64","null_value":0,"comment":"Stator Leakage Reactance","valid_range":{"max":null,"min":0}},{"name":"Tcomp","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Time measured with compensated frequency","valid_range":{"max":null,"min":"eps()"}},{"name":"hysteresis_binary_logic","default":"1","data_type":"Int","null_value":0,"comment":"Hysteresis memory variable"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tx_p1: 1st washout 1st input, \n\tx_p2: 2nd washout 1st input, \n\tx_p3: transducer 1st input, \n\tx_p4: 1st washout 2nd input, \n\tx_p5: 2nd washout 2nd input, \n\tx_p6: transducer 2nd input, \n\tx_p7: ramp tracking filter state 1, \n\tx_p8: ramp tracking filter state 2, \n\tx_p9: ramp tracking filter state 3, \n\tx_p10: ramp tracking filter state 4, \n\tx_p11: ramp tracking filter state 5, \n\tx_p12: ramp tracking filter state 6, \n\tx_p13: ramp tracking filter state 7, \n\tx_p14: ramp tracking filter state 8, \n\tx_p15: 1st lead-lag, \n\tx_p16: 2nd lead-lag, \n\tx_p17: 3rd lead-lag, \n\tx_p18: 4th lead-lag, \n\tx_p19: washout block for compensated frequency,","internal_default":"[:x_p1, :x_p2, :x_p3, :x_p4, :x_p5, :x_p6, :x_p7, :x_p8, :x_p9, :x_p10, :x_p11, :x_p12, :x_p13, :x_p14, :x_p15, :x_p16, :x_p17, :x_p18, :x_p19]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"IEEEST has 19 states","internal_default":19},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"IEEEST has 19 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"IEEE 421.5 2016 PSS2C IEEE Dual-Input Stabilizer Model","struct_name":"PSS2C","supertype":"PSS"},{"fields":[{"name":"H","data_type":"Float64","null_value":0,"comment":"Rotor inertia constant in MWs/MVA","valid_range":{"max":null,"min":0}},{"name":"D","data_type":"Float64","null_value":0,"comment":"Rotor natural damping in pu","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tδ: rotor angle,\n\tω: rotor speed","internal_default":"[:δ, :ω]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"SingleMass has 1 state","internal_default":2},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of single mass shaft model. Typically represents the rotor mass.","struct_name":"SingleMass","supertype":"Shaft"},{"fields":[{"name":"H","data_type":"Float64","null_value":0,"comment":"Rotor inertia constant in MWs/MVA","valid_range":{"max":null,"min":0}},{"name":"H_hp","data_type":"Float64","null_value":0,"comment":"High pressure turbine inertia constant in MWs/MVA","valid_range":{"max":null,"min":0}},{"name":"H_ip","data_type":"Float64","null_value":0,"comment":"Intermediate pressure turbine inertia constant in MWs/MVA","valid_range":{"max":null,"min":0}},{"name":"H_lp","data_type":"Float64","null_value":0,"comment":"Low pressure turbine inertia constant in MWs/MVA","valid_range":{"max":null,"min":0}},{"name":"H_ex","data_type":"Float64","null_value":0,"comment":" Exciter inertia constant in MWs/MVA","valid_range":{"max":null,"min":0}},{"name":"D","data_type":"Float64","null_value":0,"comment":"Rotor natural damping in pu","valid_range":{"max":null,"min":0}},{"name":"D_hp","data_type":"Float64","null_value":0,"comment":"High pressure turbine natural damping in pu","valid_range":{"max":null,"min":0}},{"name":"D_ip","data_type":"Float64","null_value":0,"comment":"Intermediate pressure turbine natural damping in pu","valid_range":{"max":null,"min":0}},{"name":"D_lp","data_type":"Float64","null_value":0,"comment":"Low pressure turbine natural damping in pu","valid_range":{"max":null,"min":0}},{"name":"D_ex","data_type":"Float64","null_value":0,"comment":"Exciter natural damping in pu","valid_range":{"max":null,"min":0}},{"name":"D_12","data_type":"Float64","null_value":0,"comment":"High-Intermediate pressure turbine damping","valid_range":{"max":null,"min":0}},{"name":"D_23","data_type":"Float64","null_value":0,"comment":"Intermediate-Low pressure turbine damping","valid_range":{"max":null,"min":0}},{"name":"D_34","data_type":"Float64","null_value":0,"comment":"Low pressure turbine-Rotor damping","valid_range":{"max":null,"min":0}},{"name":"D_45","data_type":"Float64","null_value":0,"comment":"Rotor-Exciter damping","valid_range":{"max":null,"min":0}},{"name":"K_hp","data_type":"Float64","null_value":0,"comment":"High pressure turbine angle coefficient","valid_range":{"max":null,"min":0}},{"name":"K_ip","data_type":"Float64","null_value":0,"comment":"Intermediate pressure turbine angle coefficient","valid_range":{"max":null,"min":0}},{"name":"K_lp","data_type":"Float64","null_value":0,"comment":"Low pressure turbine angle coefficient","valid_range":{"max":null,"min":0}},{"name":"K_ex","data_type":"Float64","null_value":0,"comment":"Exciter angle coefficient","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tδ: rotor angle,\n\tω: rotor speed,\n\tδ_hp: rotor angle of high pressure turbine,\n\tω_hp: rotor speed of high pressure turbine,\n\tδ_ip: rotor angle of intermediate pressure turbine,\n\tω_ip: rotor speed of intermediate pressure turbine,\n\tδ_lp: rotor angle of low pressure turbine,\n\tω_lp: rotor speed of low pressure turbine,\n\tδ_ex: rotor angle of exciter,\n\tω_lp: rotor speed of exciter","internal_default":"[:δ, :ω, :δ_hp, :ω_hp, :δ_ip, :ω_ip, :δ_lp, :ω_lp, :δ_ex, :ω_ex]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"FiveMassShaft has 10 states","internal_default":10},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 5 mass-spring shaft model.\n It contains a High-Pressure (HP) steam turbine, Intermediate-Pressure (IP)\n steam turbine, Low-Pressure (LP) steam turbine, the Rotor and an Exciter (EX) mover.","struct_name":"FiveMassShaft","supertype":"Shaft"},{"fields":[{"name":"efficiency","data_type":"Float64","null_value":0,"comment":" Efficiency factor that multiplies P_ref","valid_range":{"max":null,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"","internal_default":"Vector{Symbol}()"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"TGFixed has no states","internal_default":0},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of a fixed Turbine Governor that returns a fixed mechanical torque\n given by the product of P_ref*efficiency","struct_name":"TGFixed","supertype":"TurbineGov"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Speed droop parameter","valid_range":{"max":0.1,"min":"eps()"}},{"name":"T1","data_type":"Float64","null_value":0,"comment":"Governor time constant in s","valid_range":{"max":0.5,"min":"eps()"}},{"name":"T2","data_type":"Float64","null_value":0,"comment":"Combustion chamber time constant","valid_range":{"max":0.5,"min":"eps()"}},{"name":"T3","data_type":"Float64","null_value":0,"comment":"Load limit time constant (exhaust gas measurement time)","valid_range":{"max":5,"min":"eps()"}},{"name":"AT","data_type":"Float64","null_value":0,"comment":"Ambient temperature load limit","valid_range":{"max":1,"min":0}},{"name":"Kt","data_type":"Float64","null_value":0,"comment":"Load limit feedback gain","valid_range":{"max":5,"min":0}},{"name":"V_lim","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Operational control limits on fuel valve opening (V_min, V_max)"},{"name":"D_turb","data_type":"Float64","null_value":0,"comment":"Speed damping coefficient of gas turbine rotor","valid_range":{"max":0.5,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Load Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the GAST model are:\n\tx_g1: Fuel valve opening,\n\tx_g2: Fuel flow,\n\tx_g3: Exhaust temperature load","internal_default":"[:x_g1, :x_g2, :x_g3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"GasTG has 3 states","internal_default":3},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"GAST has 3 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of Gas Turbine-Governor. GAST in PSSE and GAST_PTI in PowerWorld.","struct_name":"GasTG","supertype":"TurbineGov"},{"fields":[{"name":"T1","data_type":"Float64","null_value":0,"comment":"Governor mechanism time constant","valid_range":{"max":100,"min":"eps()"}},{"name":"T2","data_type":"Float64","null_value":0,"comment":"Turbine power time constant","valid_range":{"max":100,"min":"eps()"}},{"name":"T3","data_type":"Float64","null_value":0,"comment":"Turbine exhaust temperature time constant","valid_range":{"max":100,"min":"eps()"}},{"name":"K","data_type":"Float64","null_value":0,"comment":"Governor gain (reciprocal of droop)","valid_range":{"max":100,"min":"eps()"}},{"name":"T4","data_type":"Float64","null_value":0,"comment":"Governor lead time constant","valid_range":{"max":100,"min":"eps()"}},{"name":"T5","data_type":"Float64","null_value":0,"comment":"Governor lag time constant","valid_range":{"max":100,"min":"eps()"}},{"name":"T6","data_type":"Float64","null_value":0,"comment":"Actuator time constant","valid_range":{"max":100,"min":"eps()"}},{"name":"Td","data_type":"Float64","null_value":0,"comment":"Engine time delay","valid_range":{"max":100,"min":"eps()"}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Load Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the DEGOV model are:\n\tx_ecb1: Electric control box 1,\n\tx_ecb2: Electric control box 2,\n\tx_a1: Actuator 1,\n\tx_a2: Actuator 2,\n\tx_a3: Actuator 3,","internal_default":"[:x_ecb1, :x_ecb2, :x_a1, :x_a2, :x_a3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"DEGOV has 5 states","internal_default":5},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"DEGOV has 5 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters Woodward Diesel Governor Model. DEGOV in PowerWorld.","struct_name":"DEGOV","supertype":"TurbineGov"},{"fields":[{"name":"Rselect","data_type":"Int","null_value":1,"validation_action":"error","comment":"Feedback signal for governor droop","valid_range":{"max":1,"min":-2}},{"name":"fuel_flag","data_type":"Int","null_value":0,"validation_action":"error","comment":"Flag Switch for fuel source characteristic","valid_range":{"max":1,"min":0}},{"name":"R","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Speed droop parameter","valid_range":{"max":null,"min":"eps()"}},{"name":"Tpelec","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Electrical power transducer time constant, seconds","valid_range":{"max":null,"min":"eps()"}},{"name":"speed_error_signal","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Speed error signal limits"},{"name":"Kp_gov","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Governor proportional gain","valid_range":{"max":null,"min":0}},{"name":"Ki_gov","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Governor integral gain","valid_range":{"max":null,"min":0}},{"name":"Kd_gov","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Governor derivative gain","valid_range":{"max":null,"min":0}},{"name":"Td_gov","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Governor derivative time constant","valid_range":{"max":null,"min":0}},{"name":"valve_position_limits","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Valve position limits"},{"name":"T_act","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Actuator time constant","valid_range":{"max":null,"min":0}},{"name":"K_turb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Turbine gain","valid_range":{"max":null,"min":0}},{"name":"Wf_nl","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"No load fuel flow, pu","valid_range":{"max":null,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Turbine lag time constant, sec","valid_range":{"max":null,"min":0}},{"name":"Tc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Turbine lead time constant, sec","valid_range":{"max":null,"min":0}},{"name":"T_eng","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Transport lag time constant for diesel engine, sec","valid_range":{"max":null,"min":0}},{"name":"Tf_load","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Load limiter time constant","valid_range":{"max":null,"min":0}},{"name":"Kp_load","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Load limiter proportional gain for PI controller","valid_range":{"max":null,"min":0}},{"name":"Ki_load","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Load integral gain for PI controller","valid_range":{"max":null,"min":0}},{"name":"Ld_ref","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Load limiter integral gain for PI controller","valid_range":{"max":null,"min":0}},{"name":"Dm","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Mechanical damping coefficient, pu","valid_range":{"max":null,"min":0}},{"name":"R_open","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Maximum valve opening rate, pu/sec","valid_range":{"max":null,"min":0}},{"name":"R_close","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Maximum valve closing rate, pu/sec","valid_range":{"max":null,"min":0}},{"name":"Ki_mw","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Power controller (reset) gain","valid_range":{"max":null,"min":0}},{"name":"A_set","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Acceleration limiter setpoint, pu/sec","valid_range":{"max":null,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Acceleration limiter gain","valid_range":{"max":null,"min":0}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Acceleration limiter time constant ","valid_range":{"max":null,"min":"eps()"}},{"name":"T_rate","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Turbine rating","valid_range":{"max":null,"min":0}},{"name":"db","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Speed governor deadband","valid_range":{"max":null,"min":0}},{"name":"Tsa","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Temperature detection lead time constant","valid_range":{"max":null,"min":0}},{"name":"Tsb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Temperature detection lag time constant","valid_range":{"max":null,"min":0}},{"name":"R_lim","data_type":"UpDown","null_value":"(up = 0.0, down = 0.0)","comment":"Maximum rate of load increa"},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the GGOV1 model are:\n\tPe: Machine Electrical Power Measurement,\n\tx_g1: Governor differential control,\n\tx_g2: Governor integral control, \n\tx_g3: Turbine actuator, \n\tx_g4: Turbine Lead-Lag, \n\tx_g5: Turbine load limiter measurement, \n\tx_g6: Turbine Load Limiter Integral Control, \n\tx_g7: Supervisory Load Control, \n\tx_g8: Acceleration Control, \n\tx_g9 Temperature Detection Lead - Lag:","internal_default":"[:Pe, :x_g1, :x_g2, :x_g3, :x_g4, :x_g5, :x_g6, :x_g7, :x_g8, :x_g9]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"GeneralGovModel has 10 states","internal_default":10},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"GGOV1 has 10 differential states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential, StateTypes.Hybrid]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"GE General Governor/Turbine Model. The GeneralGovModel (GGOV1) model is a general purpose governor model used for a variety of prime movers controlled by proportional-integral-derivative (PID) governors including gas turbines.","struct_name":"GeneralGovModel","supertype":"TurbineGov"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Droop parameter","valid_range":{"max":0.1,"min":0}},{"name":"T1","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Governor time constant","valid_range":{"max":0.5,"min":"eps()"}},{"name":"valve_position_limits","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Valve position limits"},{"name":"T2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Lead Lag Lead Time constant ","valid_range":{"max":null,"min":0}},{"name":"T3","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Lead Lag Lag Time constant ","valid_range":{"max":10,"min":"eps()"}},{"name":"D_T","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Turbine Damping","valid_range":{"max":0.5,"min":0}},{"name":"DB_h","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Deadband for overspeed","valid_range":{"max":null,"min":0}},{"name":"DB_l","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Deadband for underspeed","valid_range":{"max":0,"min":null}},{"name":"T_rate","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Turbine Rate (MW). If zero, generator base is used.","valid_range":{"max":null,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the SteamTurbineGov1 model are:\n\tx_g1: Valve Opening,\n\tx_g2: Lead-lag state","internal_default":"[:x_g1, :x_g2]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"TGOV1 has 2 states","internal_default":2},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"TGOV1 has 2 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Steam Turbine-Governor. This model considers both TGOV1 or TGOV1DU in PSS/E.","struct_name":"SteamTurbineGov1","supertype":"TurbineGov"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Permanent droop parameter","valid_range":{"max":0.1,"min":0}},{"name":"r","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Temporary Droop","valid_range":{"max":2,"min":0}},{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Governor time constant","valid_range":{"max":30,"min":"eps()"}},{"valiation_action":"error","name":"Tf","data_type":"Float64","null_value":0,"comment":"Filter Time constant","valid_range":{"max":0.1,"min":"eps()"}},{"name":"Tg","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Servo time constant","valid_range":{"max":1,"min":"eps()"}},{"name":"VELM","data_type":"Float64","null_value":0,"validation_action":"error","comment":"gate velocity limit","valid_range":{"max":0.3,"min":"eps()"}},{"name":"gate_position_limits","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Gate position limits"},{"name":"Tw","data_type":"Float64","null_value":0,"validation_action":"error","comment":"water time constant","valid_range":{"max":3,"min":"eps()"}},{"name":"At","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Turbine gain","valid_range":{"max":1.5,"min":0.8}},{"name":"D_T","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Turbine Damping","valid_range":{"max":0.5,"min":0}},{"name":"q_nl","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"No-power flow","valid_range":{"max":null,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the HydroTurbineGov model are:\n\tx_g1: filter_output,\n\tx_g2: desired gate, \n\tx_g3: gate opening, \n\tx_g4: turbine flow","internal_default":"[:x_g1, :x_g2, :x_g3, :x_g4]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"HYGOV has 4 states","internal_default":4},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"HYGOV has 4 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Hydro Turbine-Governor.","struct_name":"HydroTurbineGov","supertype":"TurbineGov"},{"fields":[{"name":"K","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Governor Gain","valid_range":{"max":30,"min":5}},{"name":"T1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Input Filter Lag","valid_range":{"max":5,"min":0}},{"name":"T2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Input Filter Lead","valid_range":{"max":10,"min":0}},{"name":"T3","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Valve position Time Constant","valid_range":{"max":1,"min":"eps()"}},{"name":"U0","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Maximum Valve Opening Rate","valid_range":{"max":0.03,"min":0.01}},{"name":"U_c","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Maximum Valve closing rate","valid_range":{"max":0,"min":-0.3}},{"name":"valve_position_limits","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Valve position limits in MW"},{"name":"T4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time Constant inlet steam","valid_range":{"max":1,"min":0}},{"name":"K1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Fraction of high presure shaft power","valid_range":{"max":1,"min":-2}},{"name":"K2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Fraction of low presure shaft power","valid_range":{"max":null,"min":0}},{"name":"T5","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second boiler pass","valid_range":{"max":10,"min":0}},{"name":"K3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Fraction of high presure shaft power second boiler pass","valid_range":{"max":0.5,"min":0}},{"name":"K4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Fraction of low presure shaft power second boiler pass","valid_range":{"max":0.5,"min":0}},{"name":"T6","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for third boiler pass","valid_range":{"max":10,"min":0}},{"name":"K5","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Fraction of high presure shaft power third boiler pass","valid_range":{"max":0.35,"min":0}},{"name":"K6","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Fraction of low presure shaft power third boiler pass","valid_range":{"max":0.55,"min":0}},{"name":"T7","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for fourth boiler pass","valid_range":{"max":10,"min":0}},{"name":"K7","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Fraction of high presure shaft power fourth boiler pass","valid_range":{"max":0.3,"min":0}},{"name":"K8","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Fraction of low presure shaft power fourth boiler pass","valid_range":{"max":0.3,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the IEEETurbineGov model are:\n\tx_g1: First Governor integrator,\n\tx_g2: Governor output,\n\tx_g3: First Turbine integrator, \n\tx_g4: Second Turbine Integrator, \n\tx_g5: Third Turbine Integrator, \n\tx_g6: Fourth Turbine Integrator, ","internal_default":"[:x_g1, :x_g2, :x_g3, :x_g4, :x_g5, :x_g6]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"IEEEG1 has 6 states","internal_default":6},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"IEEEG1 has 6 differential states","internal_default":"[StateTypes.Differential, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"IEEE Type 1 Speed-Governing Model","struct_name":"IEEETurbineGov1","supertype":"TurbineGov"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Droop parameter","valid_range":{"max":null,"min":0}},{"name":"Ts","data_type":"Float64","null_value":0,"comment":"Governor time constant","valid_range":{"max":null,"min":0}},{"name":"Tc","data_type":"Float64","null_value":0,"comment":"Servo time constant","valid_range":{"max":null,"min":0}},{"name":"T3","data_type":"Float64","null_value":0,"comment":"Transient gain time constant","valid_range":{"max":null,"min":0}},{"name":"T4","data_type":"Float64","null_value":0,"comment":"Power fraction time constant","valid_range":{"max":null,"min":0}},{"name":"T5","data_type":"Float64","null_value":0,"comment":"Reheat time constant","valid_range":{"max":null,"min":0}},{"name":"valve_position_limits","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Valve position limits in MW"},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the TGTypeI model are:\n\tx_g1: Governor state,\n\tx_g2: Servo state,\n\tx_g3: Reheat state","internal_default":"[:x_g1, :x_g2, :x_g3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"TGTypeI has 3 states","internal_default":3},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of a Turbine Governor Type I.","struct_name":"TGTypeI","supertype":"TurbineGov"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Droop parameter","valid_range":{"max":null,"min":0}},{"name":"T1","data_type":"Float64","null_value":0,"comment":"Transient gain time constant","valid_range":{"max":null,"min":0}},{"name":"T2","data_type":"Float64","null_value":0,"comment":"Power fraction time constant","valid_range":{"max":null,"min":0}},{"name":"τ_limits","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Power into the governor limits"},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the TGTypeI model are:\n\tx_g1: lead-lag state","internal_default":"[:xg]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"TGTypeII has 1 state","internal_default":1},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of a Turbine Governor Type II.","struct_name":"TGTypeII","supertype":"TurbineGov"},{"fields":[{"name":"rated_voltage","data_type":"Float64","null_value":0,"comment":"rated voltage","valid_range":{"max":null,"min":0}},{"name":"rated_current","data_type":"Float64","null_value":0,"comment":"rated VA","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"","internal_default":"Vector{Symbol}()"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"AverageConverter has no states","internal_default":0}],"docstring":"Parameters of an average converter model","struct_name":"AverageConverter","supertype":"Converter"},{"fields":[{"name":"T_g","data_type":"Float64","null_value":0,"comment":"Converter time constant (s)","valid_range":{"max":null,"min":0}},{"name":"Rrpwr","data_type":"Float64","null_value":0,"comment":"Low Voltage Power Logic (LVPL) ramp rate limit (pu/s)","valid_range":{"max":null,"min":0}},{"name":"Brkpt","data_type":"Float64","null_value":0,"comment":"LVPL characteristic voltage 2 (pu)","valid_range":{"max":null,"min":0}},{"name":"Zerox","data_type":"Float64","null_value":0,"comment":"LVPL characteristic voltage 1 (pu)","valid_range":{"max":null,"min":0}},{"name":"Lvpl1","data_type":"Float64","null_value":0,"comment":"LVPL gain (pu)","valid_range":{"max":null,"min":0}},{"name":"Vo_lim","data_type":"Float64","null_value":0,"comment":"Voltage limit for high voltage reactive current management (pu)","valid_range":{"max":null,"min":0}},{"name":"Lv_pnts","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Voltage points for low voltage active current management (pu) (Lvpnt0, Lvpnt1)"},{"name":"Io_lim","data_type":"Float64","null_value":0,"comment":"Current limit (pu) for high voltage reactive current management (specified as a negative value)","valid_range":{"max":0,"min":null}},{"name":"T_fltr","data_type":"Float64","null_value":0,"comment":"Voltage filter time constant for low voltage active current management (s)","valid_range":{"max":null,"min":0}},{"name":"K_hv","data_type":"Float64","null_value":0,"comment":"Overvoltage compensation gain used in the high voltage reactive current management","valid_range":{"max":null,"min":0}},{"name":"Iqr_lims","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limit on rate of change for reactive current (pu/s) (Iqr_min, Iqr_max)"},{"name":"Accel","data_type":"Float64","null_value":0,"comment":"Acceleration factor","valid_range":{"max":1,"min":0}},{"name":"Lvpl_sw","data_type":"Int","null_value":0,"comment":"Low voltage power logic (LVPL) switch. (0: LVPL not present, 1: LVPL present)","valid_range":{"max":1,"min":0}},{"name":"Q_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Initial machine reactive power from power flow","valid_range":{"max":null,"min":0}},{"name":"R_source","default":"0.0","data_type":"Float64","null_value":0,"comment":"Output resistor used for the Thevenin Equivalent","valid_range":{"max":null,"min":0}},{"name":"X_source","default":"1.0e5","data_type":"Float64","null_value":0,"comment":"Output resistor used for the Thevenin Equivalent","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\tIp: Converter lag for Ipcmd,\tIq: Converter lag for Iqcmd,\tVmeas: Voltage filter for low voltage active current management","internal_default":"[:Ip, :Iq, :Vmeas]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"RenewableEnergyConverterTypeA has 3 states","internal_default":3}],"docstring":"Parameters of a renewable energy generator/converter model, this model corresponds to REGCA1 in PSSE","struct_name":"RenewableEnergyConverterTypeA","supertype":"Converter"},{"fields":[{"name":"T_g","data_type":"Float64","null_value":0,"comment":"Converter time constant (s)","valid_range":{"max":null,"min":0}},{"name":"Rrpwr","data_type":"Float64","null_value":0,"comment":"Low Voltage Power Logic (LVPL) ramp rate limit (pu/s)","valid_range":{"max":null,"min":0}},{"name":"Brkpt","data_type":"Float64","null_value":0,"comment":"LVPL characteristic voltage 2 (pu)","valid_range":{"max":null,"min":0}},{"name":"Zerox","data_type":"Float64","null_value":0,"comment":"LVPL characteristic voltage 1 (pu)","valid_range":{"max":null,"min":0}},{"name":"Lvpl1","data_type":"Float64","null_value":0,"comment":"LVPL gain (pu)","valid_range":{"max":null,"min":0}},{"name":"Vo_lim","data_type":"Float64","null_value":0,"comment":"Voltage limit for high voltage reactive current management (pu)","valid_range":{"max":null,"min":0}},{"name":"Lv_pnts","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Voltage points for low voltage active current management (pu) (Lvpnt0, Lvpnt1)"},{"name":"Io_lim","data_type":"Float64","null_value":0,"comment":"Current limit (pu) for high voltage reactive current management (specified as a negative value)","valid_range":{"max":0,"min":null}},{"name":"T_fltr","data_type":"Float64","null_value":0,"comment":"Voltage filter time constant for low voltage active current management (s)","valid_range":{"max":null,"min":0}},{"name":"K_hv","data_type":"Float64","null_value":0,"comment":"Overvoltage compensation gain used in the high voltage reactive current management","valid_range":{"max":null,"min":0}},{"name":"Iqr_lims","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limit on rate of change for reactive current (pu/s) (Iqr_min, Iqr_max)"},{"name":"Accel","data_type":"Float64","null_value":0,"comment":"Acceleration factor","valid_range":{"max":1,"min":0}},{"name":"Lvpl_sw","data_type":"Int","null_value":0,"comment":"Low voltage power logic (LVPL) switch. (0: LVPL not present, 1: LVPL present)","valid_range":{"max":1,"min":0}},{"name":"Q_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Initial machine reactive power from power flow","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\tIp: Converter lag for Ipcmd,\tIq: Converter lag for Iqcmd,\tVmeas: Voltage filter for low voltage active current management","internal_default":"[:Ip, :Iq, :Vmeas]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"RenewableEnergyVoltageConverterTypeA has 3 states","internal_default":3}],"docstring":"Parameters of a renewable energy generator/converter model, this model corresponds to REGCA1 in PSSE, but to be interfaced using a Voltage Source instead of a Current Source.","struct_name":"RenewableEnergyVoltageConverterTypeA","supertype":"Converter"},{"fields":[{"name":"voltage","data_type":"Float64","null_value":0,"comment":"rated VA","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"","internal_default":"Vector{Symbol}()"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"FixedDCSource has no states","internal_default":0},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of a Fixed DC Source that returns a fixed DC voltage","struct_name":"FixedDCSource","supertype":"DCSource"},{"fields":[{"name":"rated_voltage","data_type":"Float64","null_value":0,"comment":"rated voltage","valid_range":{"max":null,"min":0}},{"name":"rated_current","data_type":"Float64","null_value":0,"comment":"rated current","valid_range":{"max":null,"min":0}},{"name":"battery_voltage","data_type":"Float64","null_value":0,"comment":"battery voltage","valid_range":{"max":null,"min":0}},{"name":"battery_resistance","data_type":"Float64","null_value":0,"comment":"battery_resistance","valid_range":{"max":null,"min":0}},{"name":"dc_dc_inductor","data_type":"Float64","null_value":0,"comment":"DC/DC inductance","valid_range":{"max":null,"min":0}},{"name":"dc_link_capacitance","data_type":"Float64","null_value":0,"comment":"DC-link capacitor","valid_range":{"max":null,"min":0}},{"name":"fs","data_type":"Float64","null_value":0,"comment":"DC/DC converter switching frequency","valid_range":{"max":null,"min":0}},{"name":"kpv","data_type":"Float64","null_value":0,"comment":"voltage controller proportional gain","valid_range":{"max":null,"min":0}},{"name":"kiv","data_type":"Float64","null_value":0,"comment":"voltage controller integral gain","valid_range":{"max":null,"min":0}},{"name":"kpi","data_type":"Float64","null_value":0,"comment":"current controller proportional gain","valid_range":{"max":null,"min":0}},{"name":"kii","data_type":"Float64","null_value":0,"comment":"current controller integral gain","valid_range":{"max":null,"min":0}},{"name":"Vdc_ref","default":"1.1","data_type":"Float64","null_value":0,"comment":"Reference DC-Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the ZeroOrderBESS model are:\n\tv_dc: DC-link votlage,\n\ti_b: Battery current,\n\t ν: integrator state of the voltage controller,\n\t ζ: integrator state of the PI current controller","internal_default":"[:v_dc, :i_b, :ν, :ζ]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ZeroOrderBESS has 4 states","internal_default":4}],"docstring":"Parameters for the DC-side with a Battery Energy Storage System from paper at https://arxiv.org/abs/2007.11776","struct_name":"ZeroOrderBESS","supertype":"DCSource"},{"fields":[{"name":"lf","data_type":"Float64","null_value":0,"comment":"Series inductance in p.u. of converter filter","valid_range":{"max":null,"min":0}},{"name":"rf","data_type":"Float64","null_value":0,"comment":"Series resistance in p.u. of converter filter","valid_range":{"max":null,"min":0}},{"name":"cf","data_type":"Float64","null_value":0,"comment":"Shunt capacitance in p.u. of converter filter","valid_range":{"max":null,"min":0}},{"name":"lg","data_type":"Float64","null_value":0,"comment":"Series inductance in p.u. of converter filter to the grid","valid_range":{"max":null,"min":0}},{"name":"rg","data_type":"Float64","null_value":0,"comment":"Series resistance in p.u. of converter filter to the grid","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the LCLFilter model are:\n\tir_cnv: Real current out of the converter,\n\tii_cnv: Imaginary current out of the converter,\n\tvr_filter: Real voltage at the filter's capacitor,\n\tvi_filter: Imaginary voltage at the filter's capacitor,\n\tir_filter: Real current out of the filter,\n\tii_filter: Imaginary current out of the filter","internal_default":"[:ir_cnv, :ii_cnv, :vr_filter, :vi_filter, :ir_filter, :ii_filter]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"LCLFilter has 6 states","internal_default":6}],"docstring":"Parameters of a LCL filter outside the converter, the states are in the grid's reference frame","struct_name":"LCLFilter","supertype":"Filter"},{"fields":[{"name":"lf","data_type":"Float64","null_value":0,"comment":"filter inductance","valid_range":{"max":null,"min":0}},{"name":"rf","data_type":"Float64","null_value":0,"comment":"filter resistance","valid_range":{"max":null,"min":0}},{"name":"cf","data_type":"Float64","null_value":0,"comment":"filter capacitance","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the LCFilter model are:\n\tir_filter: Real current out of the filter,\n\tii_filter: Imaginary current out of the filter","internal_default":"[:ir_filter, :ii_filter]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"LCFilter has two states","internal_default":2}],"docstring":"Parameters of a LCL filter outside the converter","struct_name":"LCFilter","supertype":"Filter"},{"fields":[{"name":"rf","data_type":"Float64","null_value":0,"comment":"Series resistance in p.u. of converter filter to the grid","valid_range":{"max":null,"min":0}},{"name":"lf","data_type":"Float64","null_value":0,"comment":"Series inductance in p.u. of converter filter to the grid","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"RLFilter has zero states","internal_default":"Vector{Symbol}()"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"RLFilter has zero states","internal_default":0}],"docstring":"Parameters of RL series filter in algebraic representation","struct_name":"RLFilter","supertype":"Filter"},{"fields":[{"name":"ω_lp","data_type":"Float64","null_value":0,"comment":"PLL low-pass filter frequency (rad/sec)","valid_range":{"max":null,"min":0}},{"name":"kp_pll","data_type":"Float64","null_value":0,"comment":"PLL proportional gain","valid_range":{"max":null,"min":0}},{"name":"ki_pll","data_type":"Float64","null_value":0,"comment":"PLL integral gain","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the KauraPLL model are:\n\tvd_pll: d-axis of the measured voltage in the PLL synchronous reference frame (SRF),\n\tvq_pll: q-axis of the measured voltage in the PLL SRF,\n\tε_pll: Integrator state of the PI controller,\n\tθ_pll: Phase angle displacement in the PLL SRF","internal_default":"[:vd_pll, :vq_pll, :ε_pll, :θ_pll]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"KauraPLL has 4 states","internal_default":4}],"docstring":"Parameters of a Phase-Locked Loop (PLL) based on Kaura, Vikram, and Vladimir Blasko.\n\"Operation of a phase locked loop system under distorted utility conditions.\"\nIEEE Transactions on Industry applications 33.1 (1997): 58-63.","struct_name":"KauraPLL","supertype":"FrequencyEstimator"},{"fields":[{"name":"ω_lp","data_type":"Float64","null_value":0,"comment":"PLL low-pass filter frequency (rad/sec)","valid_range":{"max":null,"min":0}},{"name":"kp_pll","data_type":"Float64","null_value":0,"comment":"PLL proportional gain","valid_range":{"max":null,"min":0}},{"name":"ki_pll","data_type":"Float64","null_value":0,"comment":"PLL integral gain","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the ReducedOrderPLL model are:\n\tvq_pll: q-axis of the measured voltage in the PLL synchronous reference frame (SRF),\n\tε_pll: Integrator state of the PI controller,\n\tθ_pll: Phase angle displacement in the PLL SRF","internal_default":"[:vq_pll, :ε_pll, :θ_pll]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ReducedOrderPLL has 3 states","internal_default":3}],"docstring":"Parameters of a Phase-Locked Loop (PLL) based on Purba, Dhople, Jafarpour, Bullo and Johnson.\n\"Reduced-order Structure-preserving Model for Parallel-connected Three-phase Grid-tied Inverters.\"\n2017 IEEE 18th Workshop on Control and Modeling for Power Electronics (COMPEL): 1-7.","struct_name":"ReducedOrderPLL","supertype":"FrequencyEstimator"},{"fields":[{"name":"frequency","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference used"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"FixedFrequency has no states","internal_default":"Vector{Symbol}()"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"FixedFrequency has no states","internal_default":0}],"docstring":"Parameters of a Fixed Frequency Estimator (i.e. no PLL).","struct_name":"FixedFrequency","supertype":"FrequencyEstimator"},{"fields":[{"name":"Ta","data_type":"Float64","null_value":0,"comment":"VSM inertia constant","valid_range":{"max":null,"min":0}},{"name":"kd","data_type":"Float64","null_value":0,"comment":"VSM damping constant","valid_range":{"max":null,"min":0}},{"name":"kω","data_type":"Float64","null_value":0,"comment":"frequency droop gain","valid_range":{"max":null,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the VirtualInertia model are:\n\tθ_oc: Phase angle displacement of the virtual synchronous generator model\n\tω_oc: Speed of the rotating reference frame of the virtual synchronous generator model","internal_default":"[:θ_oc, :ω_oc]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"VirtualInertia has two states","internal_default":2}],"docstring":"Parameters of a Virtual Inertia with SRF using VSM for active power controller","struct_name":"VirtualInertia","supertype":"ActivePowerControl"},{"fields":[{"name":"Rp","data_type":"Float64","null_value":0,"comment":"Droop Gain","valid_range":{"max":null,"min":0}},{"name":"ωz","data_type":"Float64","null_value":0,"comment":"filter frequency cutoff","valid_range":{"max":null,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the ActivePowerDroop model are:\n\tθ_oc: Phase angle displacement of the inverter model,\n\tp_oc: Measured active power of the inverter model","internal_default":"[:θ_oc, :p_oc]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ActivePowerDroop has two states","internal_default":2}],"docstring":"Parameters of an Active Power droop controller","struct_name":"ActivePowerDroop","supertype":"ActivePowerControl"},{"fields":[{"name":"Kp_p","data_type":"Float64","null_value":0,"comment":"Proportional Gain","valid_range":{"max":null,"min":0}},{"name":"Ki_p","data_type":"Float64","null_value":0,"comment":"Integral Gain","valid_range":{"max":null,"min":0}},{"name":"ωz","data_type":"Float64","null_value":0,"comment":"filter frequency cutoff","valid_range":{"max":null,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the ActivePowerPI model are:\n\tσp_oc: Integrator state of the PI Controller,\n\tp_oc: Measured active power of the inverter model","internal_default":"[:σp_oc, :p_oc]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ActivePowerPI has two states","internal_default":2}],"docstring":"Parameters of a Proportional-Integral Active Power controller for a specified power reference","struct_name":"ActivePowerPI","supertype":"ActivePowerControl"},{"fields":[{"name":"k1","data_type":"Float64","null_value":0,"comment":"VOC Synchronization Gain","valid_range":{"max":null,"min":0}},{"name":"ψ","data_type":"Float64","null_value":0,"comment":"Rotation angle of the controller","valid_range":{"max":null,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the ActiveVirtualOscillator model are:\n\tθ_oc: Phase angle displacement of the inverter model","internal_default":"[:θ_oc]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ActiveVirtualOscillator has one state","internal_default":1}],"docstring":"Parameters of an Active Virtual Oscillator controller. Model is based from the paper Model Reduction for Inverters with Current Limiting and Dispatchable Virtual Oscillator Control by O. Ajala et al.","struct_name":"ActiveVirtualOscillator","supertype":"ActivePowerControl"},{"fields":[{"name":"bus_control","data_type":"Int","null_value":0,"comment":"Bus Number for voltage control; ","valid_range":{"max":null,"min":0}},{"name":"from_branch_control","data_type":"Int","null_value":0,"comment":"Monitored branch FROM bus number for line drop compensation (if 0 generator power will be used)","valid_range":{"max":null,"min":0}},{"name":"to_branch_control","data_type":"Int","null_value":0,"comment":"Monitored branch TO bus number for line drop compensation (if 0 generator power will be used)","valid_range":{"max":null,"min":0}},{"name":"branch_id_control","data_type":"String","null_value":0,"comment":"Branch circuit id for line drop compensation (as a string). If 0 generator power will be used"},{"name":"Freq_Flag","data_type":"Int","null_value":0,"comment":"Frequency Flag for REPCA1: 0: disable, 1:enable","valid_range":{"max":1,"min":0}},{"name":"K_pg","data_type":"Float64","null_value":0,"comment":"Active power PI control proportional gain","valid_range":{"max":null,"min":0}},{"name":"K_ig","data_type":"Float64","null_value":0,"comment":"Active power PI control integral gain","valid_range":{"max":null,"min":0}},{"name":"T_p","data_type":"Float64","null_value":0,"comment":"Real power measurement filter time constant (s)","valid_range":{"max":null,"min":0}},{"name":"fdbd_pnts","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Frequency error dead band thresholds `(fdbd1, fdbd2)`"},{"name":"fe_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Upper/Lower limit on frequency error `(fe_min, fe_max)`"},{"name":"P_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Upper/Lower limit on power reference `(P_min, P_max)`"},{"name":"T_g","data_type":"Float64","null_value":0,"comment":"Power Controller lag time constant","valid_range":{"max":null,"min":0}},{"name":"D_dn","data_type":"Float64","null_value":0,"comment":"Droop for over-frequency conditions","valid_range":{"max":0,"min":null}},{"name":"D_up","data_type":"Float64","null_value":0,"comment":"Droop for under-frequency conditions","valid_range":{"max":null,"min":0}},{"name":"dP_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Upper/Lower limit on power reference ramp rates`(dP_min, dP_max)`"},{"name":"P_lim_inner","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Upper/Lower limit on power reference for REECB`(P_min_inner, P_max_inner)`"},{"name":"T_pord","data_type":"Float64","null_value":0,"comment":"Power filter time constant REECB time constant","valid_range":{"max":null,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the ActiveRenewableControllerAB model depends on the Flag","internal_default":"PowerSystems.get_activeRETypeAB_states(Freq_Flag)[1]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The states of the ActiveRenewableControllerAB model depends on the Flag","internal_default":"PowerSystems.get_activeRETypeAB_states(Freq_Flag)[2]"}],"docstring":"Parameters of Active Power Controller including REPCA1 and REECB1","struct_name":"ActiveRenewableControllerAB","supertype":"ActivePowerControl"},{"fields":[{"name":"bus_control","data_type":"Int","null_value":0,"comment":"Bus Number for voltage control; ","valid_range":{"max":null,"min":0}},{"name":"from_branch_control","data_type":"Int","null_value":0,"comment":"Monitored branch FROM bus number for line drop compensation (if 0 generator power will be used)","valid_range":{"max":null,"min":0}},{"name":"to_branch_control","data_type":"Int","null_value":0,"comment":"Monitored branch TO bus number for line drop compensation (if 0 generator power will be used)","valid_range":{"max":null,"min":0}},{"name":"branch_id_control","data_type":"String","null_value":0,"comment":"Branch circuit id for line drop compensation (as a string). If 0 generator power will be used"},{"name":"VC_Flag","data_type":"Int","null_value":0,"comment":"Voltage Compensator Flag for REPCA1","valid_range":{"max":1,"min":0}},{"name":"Ref_Flag","data_type":"Int","null_value":0,"comment":"Flag for Reactive Power Control for REPCA1. 0: Q-control, 1: V-control","valid_range":{"max":1,"min":0}},{"name":"PF_Flag","data_type":"Int","null_value":0,"comment":"Flag for Power Factor Control for Outer Control of REECB1. 0: Q-control, 1: Power Factor Control","valid_range":{"max":1,"min":0}},{"name":"V_Flag","data_type":"Int","null_value":0,"comment":"Flag for Voltage Control for Outer Control of REECB1. 0: Voltage Control, 1: Q-Control","valid_range":{"max":1,"min":0}},{"name":"T_fltr","data_type":"Float64","null_value":0,"comment":"Voltage or Q-power of REPCA Filter Time Constant","valid_range":{"max":null,"min":0}},{"name":"K_p","data_type":"Float64","null_value":0,"comment":"Reactive power PI control proportional gain","valid_range":{"max":null,"min":0}},{"name":"K_i","data_type":"Float64","null_value":0,"comment":"Reactive power PI control integral gain","valid_range":{"max":null,"min":0}},{"name":"T_ft","data_type":"Float64","null_value":0,"comment":"Reactive power lead time constant (s)","valid_range":{"max":null,"min":0}},{"name":"T_fv","data_type":"Float64","null_value":0,"comment":"Reactive power lag time constant (s)","valid_range":{"max":null,"min":0}},{"name":"V_frz","data_type":"Float64","null_value":0,"comment":"Voltage below which state ξq_oc (integrator state) is freeze","valid_range":{"max":null,"min":0}},{"name":"R_c","data_type":"Float64","null_value":0,"comment":"Line drop compensation resistance (used when VC_Flag = 1)","valid_range":{"max":null,"min":0}},{"name":"X_c","data_type":"Float64","null_value":0,"comment":"Line drop compensation reactance (used when VC_Flag = 1)","valid_range":{"max":null,"min":0}},{"name":"K_c","data_type":"Float64","null_value":0,"comment":"Reactive current compensation gain (pu) (used when VC_Flag = 0)","valid_range":{"max":null,"min":0}},{"name":"e_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Upper/Lower limit on Voltage or Q-power deadband output `(e_min, e_max)`"},{"name":"dbd_pnts","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Voltage or Q-power error dead band thresholds `(dbd1, dbd2)`"},{"name":"Q_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Upper/Lower limit on reactive power V/Q control in REPCA `(Q_min, Q_max)`"},{"name":"T_p","data_type":"Float64","null_value":0,"comment":"Active power lag time constant in REECB (s). Used only when PF_Flag = 1","valid_range":{"max":null,"min":0}},{"name":"Q_lim_inner","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Upper/Lower limit on reactive power input in REECB `(Q_min_inner, Q_max_inner)`. Only used when V_Flag = 1"},{"name":"V_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Upper/Lower limit on reactive power PI controller in REECB `(V_min, V_max)`. Only used when V_Flag = 1"},{"name":"K_qp","data_type":"Float64","null_value":0,"comment":"Reactive power regulator proportional gain (used when V_Flag = 1)","valid_range":{"max":null,"min":0}},{"name":"K_qi","data_type":"Float64","null_value":0,"comment":"Reactive power regulator integral gain (used when V_Flag = 1)","valid_range":{"max":null,"min":0}},{"name":"Q_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the ReactiveRenewableControllerAB model depends on the Flag","internal_default":"PowerSystems.get_reactiveRETypeAB_states(Ref_Flag, PF_Flag, V_Flag)[1]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The states of the ReactiveRenewableControllerAB model depends on the Flag","internal_default":"PowerSystems.get_reactiveRETypeAB_states(Ref_Flag, PF_Flag, V_Flag)[2]"}],"docstring":"Parameters of Reactive Power Controller including REPCA1 and REECB1","struct_name":"ReactiveRenewableControllerAB","supertype":"ReactivePowerControl"},{"fields":[{"name":"kq","data_type":"Float64","null_value":0,"comment":"frequency droop gain","valid_range":{"max":null,"min":0}},{"name":"ωf","data_type":"Float64","null_value":0,"comment":"filter frequency cutoff","valid_range":{"max":null,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the ReactivePowerDroop model are:\n\tq_oc: Filtered reactive output power","internal_default":"[:q_oc]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ReactivePowerDroop has 1 state","internal_default":1}],"docstring":"Parameters of a Reactive Power droop controller","struct_name":"ReactivePowerDroop","supertype":"ReactivePowerControl"},{"fields":[{"name":"Kp_q","data_type":"Float64","null_value":0,"comment":"Proportional Gain","valid_range":{"max":null,"min":0}},{"name":"Ki_q","data_type":"Float64","null_value":0,"comment":"Integral Gain","valid_range":{"max":null,"min":0}},{"name":"ωf","data_type":"Float64","null_value":0,"comment":"filter frequency cutoff","valid_range":{"max":null,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"Q_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reactive Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the ReactivePowerPI model are:\n\tσq_oc: Integrator state of the PI Controller,\n\tq_oc: Measured reactive power of the inverter model","internal_default":"[:σq_oc, :q_oc]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ReactivePowerPI has two states","internal_default":2}],"docstring":"Parameters of a Proportional-Integral Reactive Power controller for a specified power reference","struct_name":"ReactivePowerPI","supertype":"ReactivePowerControl"},{"fields":[{"name":"k2","data_type":"Float64","null_value":0,"comment":"VOC voltage-amplitude control gain","valid_range":{"max":null,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"Q_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Reactive Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the ReactiveVirtualOscilator model are:\n\tE_oc: voltage reference state for inner control in the d-axis","internal_default":"[:E_oc]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ReactiveVirtualOscillator has 1 state","internal_default":1}],"docstring":"Parameters of a Reactive Virtual Oscillator controller. Model is based from the paper Model Reduction for Inverters with Current Limiting and Dispatchable Virtual Oscillator Control by O. Ajala et al.","struct_name":"ReactiveVirtualOscillator","supertype":"ReactivePowerControl"},{"fields":[{"name":"kpv","data_type":"Float64","null_value":0,"comment":"voltage controller proportional gain","valid_range":{"max":null,"min":0}},{"name":"kiv","data_type":"Float64","null_value":0,"comment":"voltage controller integral gain","valid_range":{"max":null,"min":0}},{"name":"kffv","data_type":"Float64","null_value":0,"comment":"Binary variable to enable feed-forward gain of voltage.","valid_range":{"max":null,"min":0}},{"name":"rv","data_type":"Float64","null_value":0,"comment":"virtual resistance","valid_range":{"max":null,"min":0}},{"name":"lv","data_type":"Float64","null_value":0,"comment":"virtual inductance","valid_range":{"max":null,"min":0}},{"name":"kpc","data_type":"Float64","null_value":0,"comment":"current controller proportional gain","valid_range":{"max":null,"min":0}},{"name":"kic","data_type":"Float64","null_value":0,"comment":"current controller integral gain","valid_range":{"max":null,"min":0}},{"name":"kffi","data_type":"Float64","null_value":0,"comment":"Binary variable to enable feed-forward gain of current","valid_range":{"max":null,"min":0}},{"name":"ωad","data_type":"Float64","null_value":0,"comment":"active damping filter cutoff frequency (rad/sec)","valid_range":{"max":null,"min":0}},{"name":"kad","data_type":"Float64","null_value":0,"comment":"active damping gain","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the VoltageModeControl model are:\n\tξd_ic: d-axis integrator state of the PI voltage controller,\n\tξq_ic: q-axis integrator state of the PI voltage controller,\n\tγd_ic: d-axis integrator state of the PI current controller,\n\tγq_ic: q-axis integrator state of the PI current controller,\n\tϕd_ic: d-axis low-pass filter of active damping,\n\tϕq_ic: q-axis low-pass filter of active damping","internal_default":"[:ξd_ic, :ξq_ic, :γd_ic, :γq_ic, :ϕd_ic, :ϕq_ic]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"VoltageModeControl has 6 states","internal_default":6}],"docstring":"Parameters of an inner loop current control PID using virtual impedance based on D'Arco, Suul and Fosso.\n\"A Virtual Synchronous Machine implementation for distributed control of power converters in SmartGrids.\"\nElectric Power Systems Research 122 (2015) 180–197.","struct_name":"VoltageModeControl","supertype":"InnerControl"},{"fields":[{"name":"kpc","data_type":"Float64","null_value":0,"comment":"Current controller proportional gain","valid_range":{"max":null,"min":0}},{"name":"kic","data_type":"Float64","null_value":0,"comment":"Current controller integral gain","valid_range":{"max":null,"min":0}},{"name":"kffv","data_type":"Float64","null_value":0,"comment":"Gain to enable feed-forward gain of voltage.","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the CurrentModeControl model are:\n\tγd_ic: d-axis integrator state of the PI current controller,\n\tγq_ic: q-axis integrator state of the PI current controller","internal_default":"[:γd_ic, :γq_ic]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"CurrentControl has 2 states","internal_default":2}],"docstring":"Parameters of an inner loop PI current control using based on Purba, Dhople, Jafarpour, Bullo and Johnson.\n\"Reduced-order Structure-preserving Model for Parallel-connected Three-phase Grid-tied Inverters.\"\n2017 IEEE 18th Workshop on Control and Modeling for Power Electronics (COMPEL): 1-7.","struct_name":"CurrentModeControl","supertype":"InnerControl"},{"fields":[{"name":"Q_Flag","data_type":"Int","null_value":0,"comment":"Q Flag used for I_qinj","valid_range":{"max":1,"min":0}},{"name":"PQ_Flag","data_type":"Int","null_value":0,"comment":"PQ Flag used for the Current Limit Logic","valid_range":{"max":1,"min":0}},{"name":"Vdip_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for Voltage Dip Logic `(Vdip, Vup)`"},{"name":"T_rv","data_type":"Float64","null_value":0,"comment":"Voltage Filter Time Constant","valid_range":{"max":null,"min":0}},{"name":"dbd_pnts","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Voltage error deadband thresholds `(dbd1, dbd2)`"},{"name":"K_qv","data_type":"Float64","null_value":0,"comment":"Reactive current injection gain during over and undervoltage conditions","valid_range":{"max":null,"min":0}},{"name":"Iqinj_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for Iqinj `(I_qh1, I_ql1)`"},{"name":"V_ref0","data_type":"Float64","null_value":0,"comment":"User defined reference. If 0, PSID initializes to initial terminal voltage","valid_range":{"max":null,"min":0}},{"name":"K_vp","data_type":"Float64","null_value":0,"comment":"Voltage regulator proportional gain (used when QFlag = 1)","valid_range":{"max":null,"min":0}},{"name":"K_vi","data_type":"Float64","null_value":0,"comment":"Voltage regulator integral gain (used when QFlag = 1)","valid_range":{"max":null,"min":0}},{"name":"T_iq","data_type":"Float64","null_value":0,"comment":"Time constant for low-pass filter for state q_V when QFlag = 0","valid_range":{"max":null,"min":0}},{"name":"I_max","data_type":"Float64","null_value":0,"comment":"Maximum limit on total converter current","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the RECurrentControlB depends on the Flags","internal_default":"PowerSystems.get_REControlB_states(Q_Flag)"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The states of the RECurrentControlB depends on the Flags","internal_default":"2"}],"docstring":"Parameters of the Inner Control part of the REECB model in PSS/E","struct_name":"RECurrentControlB","supertype":"InnerControl"},{"fields":[{"name":"I_max","data_type":"Float64","null_value":0,"comment":"Maximum limit on current controller input current (device base)","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"}],"docstring":"Parameters of Magnitude (Circular) Current Controller Limiter","struct_name":"MagnitudeCurrentLimiter","supertype":"InverterLimiter"},{"fields":[{"name":"Id_max","data_type":"Float64","null_value":0,"comment":"Maximum limit on d-axis current controller input current (device base)","valid_range":{"max":null,"min":0}},{"name":"Iq_max","data_type":"Float64","null_value":0,"comment":"Maximum limit on d-axis current controller input current (device base)","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"}],"docstring":"Parameters of Instantaneous (Square) Current Controller Limiter","struct_name":"InstantaneousCurrentLimiter","supertype":"InverterLimiter"},{"fields":[{"name":"I_max","data_type":"Float64","null_value":0,"comment":"Maximum limit on current controller input current (device base)","valid_range":{"max":null,"min":0}},{"name":"ϕ_I","data_type":"Float64","null_value":0,"comment":"Pre-defined angle (measured against the d-axis) for Iref once limit is hit","valid_range":{"max":1.571,"min":-1.571}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"}],"docstring":"Parameters of Priority-Based Current Controller Limiter","struct_name":"PriorityCurrentLimiter","supertype":"InverterLimiter"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"Pf_Flag","data_type":"Int","null_value":0,"comment":"Flag for Power Factor Control","valid_range":{"max":1,"min":0}},{"name":"Freq_Flag","data_type":"Int","null_value":0,"comment":"Flag to enable/disable frequency control","valid_range":{"max":1,"min":0}},{"name":"PQ_Flag","data_type":"Int","null_value":0,"comment":"Flag used to enforce maximum current","valid_range":{"max":1,"min":0}},{"name":"Gen_Flag","data_type":"Int","null_value":0,"comment":"Flag to specify generator or storage","valid_range":{"max":1,"min":0}},{"name":"Vtrip_Flag","data_type":"Int","null_value":0,"comment":"Flag to enable/disable voltage trip logic","valid_range":{"max":1,"min":0}},{"name":"Ftrip_Flag","data_type":"Int","null_value":0,"comment":"Flag to enable/disable frequency trip logic","valid_range":{"max":1,"min":0}},{"name":"T_rv","data_type":"Float64","null_value":0,"comment":"Voltage measurement transducer time constant","valid_range":{"max":null,"min":0}},{"name":"Trf","data_type":"Float64","null_value":0,"comment":"Frequency measurement transducer time constant","valid_range":{"max":null,"min":0}},{"name":"dbd_pnts","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Voltage deadband thresholds `(dbd1, dbd2)`"},{"name":"K_qv","data_type":"Float64","null_value":0,"comment":"Proportional voltage control gain (pu)","valid_range":{"max":null,"min":0}},{"name":"Tp","data_type":"Float64","null_value":0,"comment":"Power measurement transducer time constant","valid_range":{"max":null,"min":0}},{"name":"T_iq","data_type":"Float64","null_value":0,"comment":"Time constant for low-pass filter for state q_V when QFlag = 0","valid_range":{"max":null,"min":0}},{"name":"D_dn","data_type":"Float64","null_value":0,"comment":"Reciprocal of droop for over-frequency conditions (>0) (pu)","valid_range":{"max":null,"min":0}},{"name":"D_up","data_type":"Float64","null_value":0,"comment":"Reciprocal of droop for under-frequency conditions <=0) (pu)","valid_range":{"max":null,"min":0}},{"name":"fdbd_pnts","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Frequency control deadband thresholds `(fdbd1, fdbd2)`"},{"name":"fe_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Frequency error limits (femin, femax)"},{"name":"P_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Power limits (Pmin, Pmax)"},{"name":"dP_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Power reference ramp rate limits (dPmin, dPmax)"},{"name":"Tpord","data_type":"Float64","null_value":0,"comment":"Power filter time constant","valid_range":{"max":null,"min":0}},{"name":"Kpg","data_type":"Float64","null_value":0,"comment":"PI controller proportional gain (pu)","valid_range":{"max":null,"min":0}},{"name":"Kig","data_type":"Float64","null_value":0,"comment":"PI controller integral gain (pu)","valid_range":{"max":null,"min":0}},{"name":"I_max","data_type":"Float64","null_value":0,"comment":"Maximum limit on total converter current (pu)","valid_range":{"max":null,"min":0}},{"name":"vl_pnts","data_type":"Vector{Tuple{Float64,Float64}}","null_value":"[(0.0, 0.0), (0.0, 0.0)]","comment":"Low voltage cutout points `[(tv10, vl0), (tv11, vl1)]`"},{"name":"vh_pnts","data_type":"Vector{Tuple{Float64,Float64}}","null_value":"[(0.0, 0.0), (0.0, 0.0)]","comment":"High voltage cutout points `[(tvh0, vh0), (tvh1, vh1)]`"},{"name":"Vrfrac","data_type":"Float64","null_value":0,"comment":"Fraction of device that recovers after voltage comes back to within vl1 < V < vh1 (0 <= Vrfrac <= 1)","valid_range":{"max":1,"min":0}},{"name":"fl","data_type":"Float64","null_value":0,"comment":"Inverter frequency break-point for low frequency cut-out (Hz)","valid_range":{"max":null,"min":0}},{"name":"fh","data_type":"Float64","null_value":0,"comment":"Inverter frequency break-point for high frequency cut-out (Hz)","valid_range":{"max":null,"min":0}},{"name":"tfl","data_type":"Float64","null_value":0,"comment":"Low frequency cut-out timer corresponding to frequency fl (s)","valid_range":{"max":null,"min":0}},{"name":"tfh","data_type":"Float64","null_value":0,"comment":"High frequency cut-out timer corresponding to frequency fh (s)","valid_range":{"max":null,"min":0}},{"name":"Tg","data_type":"Float64","null_value":0,"comment":"Current control time constant (to represent behavior of inner control loops) (> 0) (s)","valid_range":{"max":null,"min":0}},{"name":"rrpwr","data_type":"Float64","null_value":0,"comment":"Ramp rate for real power increase following a fault (pu/s)","valid_range":{"max":null,"min":0}},{"name":"Tv","data_type":"Float64","null_value":0,"comment":"Time constant on the output of the multiplier (s)","valid_range":{"max":null,"min":0}},{"name":"Vpr","data_type":"Float64","null_value":0,"comment":"Voltage below which frequency tripping is disabled (pu)","valid_range":{"max":null,"min":0}},{"name":"Iq_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Reactive current injection limits (Iqll, Iqhl)"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"User defined voltage reference. If 0, PSID initializes to initial terminal voltage","valid_range":{"max":null,"min":0}},{"name":"Pfa_ref","default":"0.0","data_type":"Float64","null_value":0,"comment":"Reference power factor","valid_range":{"max":null,"min":0}},{"name":"ω_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference frequency","valid_range":{"max":null,"min":0}},{"name":"Q_ref","default":"0.0","data_type":"Float64","null_value":0,"comment":"Reference reactive power, in pu","valid_range":{"max":null,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference active power, in pu","valid_range":{"max":null,"min":0}},{"name":"base_power","default":"100.0","data_type":"Float64","null_value":0,"comment":"Base power"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of AggregateDistributedGenerationA depends on the Flags","internal_default":"PowerSystems.get_AggregateDistributedGenerationA_states(Freq_Flag)[1]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The states of AggregateDistributedGenerationA depends on the Flags","internal_default":"PowerSystems.get_AggregateDistributedGenerationA_states(Freq_Flag)[2]"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of the DERA1 model in PSS/E","struct_name":"AggregateDistributedGenerationA","supertype":"DynamicInjection"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","data_type":"Float64","null_value":"0.0"},{"name":"reactive_power","data_type":"Float64","null_value":"0.0"},{"name":"R_th","data_type":"Float64","null_value":0,"comment":"Source Thevenin resistance","valid_range":{"max":null,"min":0}},{"name":"X_th","data_type":"Float64","null_value":0,"comment":"Source Thevenin reactance","valid_range":{"max":null,"min":0}},{"name":"internal_voltage","default":"1.0","data_type":"Float64","null_value":0,"comment":"Internal Voltage","valid_range":{"max":null,"min":0}},{"name":"internal_angle","default":"0.0","data_type":"Float64","null_value":0,"comment":"Internal Angle"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"This struct acts as an infinity bus.","struct_name":"Source","supertype":"StaticInjection"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"R_th","data_type":"Float64","null_value":0,"comment":"Source Thevenin resistance","valid_range":{"max":null,"min":0}},{"name":"X_th","data_type":"Float64","null_value":0,"comment":"Source Thevenin reactance","valid_range":{"max":null,"min":0}},{"name":"internal_voltage_bias","default":"0.0","data_type":"Float64","null_value":0,"comment":"a0 term of the Fourier Series for the voltage"},{"name":"internal_voltage_frequencies","default":"[0.0]","data_type":"Vector{Float64}","null_value":[0],"comment":"Frequencies in radians/s"},{"name":"internal_voltage_coefficients","default":"[(0.0, 0.0)]","data_type":"Vector{Tuple{Float64,Float64}}","null_value":"[(0.0, 0.0)]","comment":"Coefficients for terms n > 1. First component corresponds to sin and second component to cos"},{"name":"internal_angle_bias","default":"0.0","data_type":"Float64","null_value":0,"comment":"a0 term of the Fourier Series for the angle"},{"name":"internal_angle_frequencies","default":"[0.0]","data_type":"Vector{Float64}","null_value":[0],"comment":"Frequencies in radians/s"},{"name":"internal_angle_coefficients","default":"[(0.0, 0.0)]","data_type":"Vector{Tuple{Float64,Float64}}","null_value":"[(0.0, 0.0)]","comment":"Coefficients for terms n > 1. First component corresponds to sin and second component to cos"},{"name":"base_power","default":"100.0","data_type":"Float64","null_value":0,"comment":"Base power"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"State for time, voltage and angle","internal_default":"[:Vt, :θt]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"null_value":2,"internal_default":2},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"This struct acts as an infinity bus with time varying phasor values magnitude and angle V(t) \theta(t). Time varying functions are represented using fourier series","struct_name":"PeriodicVariableSource","supertype":"DynamicInjection"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"Qref_Flag","data_type":"Int","null_value":1,"comment":"Reactive Power Control Mode. 1 VoltVar Control, 2 Constant Q Control, 3 Constant PF Control","valid_range":{"max":3,"min":1}},{"name":"PQ_Flag","data_type":"Int","null_value":0,"comment":"Active and reactive power priority mode. 0 for Q priority, 1 for P priority","valid_range":{"max":1,"min":0}},{"name":"Gen_Flag","data_type":"Int","null_value":0,"comment":"Define generator or storage system. 0 unit is a storage device, 1 unit is a generator","valid_range":{"max":1,"min":0}},{"name":"PerOp_Flag","data_type":"Int","null_value":0,"comment":"Defines operation of permisible region in VRT characteristic. 0 for cease, 1 for continuous operation","valid_range":{"max":1,"min":0}},{"name":"Recon_Flag","data_type":"Int","null_value":0,"comment":"Defines if DER can reconnect after voltage ride-through disconnection","valid_range":{"max":1,"min":0}},{"name":"Trv","data_type":"Float64","null_value":0,"comment":"Voltage measurement transducer's time constant, in s","valid_range":{"max":null,"min":0}},{"name":"VV_pnts","data_type":"NamedTuple{(:V1, :V2, :V3, :V4), Tuple{Float64, Float64, Float64, Float64}}","null_value":"(V1=0.0, V2=0.0, V3=0.0, V4=0.0)","comment":"Y-axis Volt-var curve points (V1,V2,V3,V4)"},{"name":"Q_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Reactive power limits in pu (Q_min, Q_max)"},{"name":"Tp","data_type":"Float64","null_value":0,"comment":"Power measurement transducer's time constant, in s","valid_range":{"max":null,"min":0}},{"name":"e_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Error limit in PI controller for q control (e_min, e_max)"},{"name":"Kpq","data_type":"Float64","null_value":0,"comment":"PI controller proportional gain for q control","valid_range":{"max":null,"min":0}},{"name":"Kiq","data_type":"Float64","null_value":0,"comment":"PI controller integral gain for q control","valid_range":{"max":null,"min":0}},{"name":"Iqr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limit on rate of change for reactive current (pu/s) (Iqr_min, Iqr_max)"},{"name":"I_max","data_type":"Float64","null_value":0,"comment":"Max. inverter's current","valid_range":{"max":null,"min":0}},{"name":"Tg","data_type":"Float64","null_value":0,"comment":"Current control's time constant, in s","valid_range":{"max":null,"min":0}},{"name":"kWh_Cap","data_type":"Float64","null_value":0,"comment":"BESS capacity in kWh","valid_range":{"max":null,"min":0}},{"name":"SOC_ini","data_type":"Float64","null_value":0,"comment":"Initial state of charge (SOC) in pu","valid_range":{"max":1,"min":0}},{"name":"SOC_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Battery's SOC limits (SOC_min, SOC_max)"},{"name":"Trf","data_type":"Float64","null_value":0,"comment":"Time constant to estimate system frequency, in s","valid_range":{"max":null,"min":0}},{"name":"fdbd_pnts","data_type":"NamedTuple{(:fdbd1, :fdbd2), Tuple{Float64, Float64}}","null_value":"(fdbd1=0.0, fdbd2=0.0)","comment":"Frequency error dead band thresholds `(fdbd1, fdbd2)`"},{"name":"D_dn","data_type":"Float64","null_value":0,"comment":"reciprocal of droop for over-frequency conditions, in pu","valid_range":{"max":null,"min":0}},{"name":"D_up","data_type":"Float64","null_value":0,"comment":"reciprocal of droop for under-frequency conditions, in pu","valid_range":{"max":null,"min":0}},{"name":"fe_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Frequency error limits in pu (fe_min, fe_max)"},{"name":"Kpp","data_type":"Float64","null_value":0,"comment":"PI controller proportional gain for p control","valid_range":{"max":null,"min":0}},{"name":"Kip","data_type":"Float64","null_value":0,"comment":"PI controller integral gain for p control","valid_range":{"max":null,"min":0}},{"name":"P_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Active power limits in pu (P_min, P_max)"},{"name":"dP_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Ramp rate limits for active power in pu/s (dP_min, dP_max)"},{"name":"T_pord","data_type":"Float64","null_value":0,"comment":"Power filter time constant in s","valid_range":{"max":null,"min":0}},{"name":"rrpwr","data_type":"Float64","null_value":0,"comment":"Ramp rate for real power increase following a fault, in pu/s","valid_range":{"max":null,"min":0}},{"name":"VRT_pnts","data_type":"NamedTuple{(:vrt1, :vrt2, :vrt3, :vrt4, :vrt5), Tuple{Float64, Float64, Float64, Float64, Float64}}","null_value":"(vrt1=0.0, vrt2=0.0, vrt3=0.0, vrt4=0.0, vrt5=0.0)","comment":"Voltage ride through v points (vrt1,vrt2,vrt3,vrt4,vrt5)"},{"name":"TVRT_pnts","data_type":"NamedTuple{(:tvrt1, :tvrt2, :tvrt3), Tuple{Float64, Float64, Float64}}","null_value":"(tvrt1=0.0, tvrt2=0.0, tvrt3=0.0)","comment":"Voltage ride through time points (tvrt1,tvrt2,tvrt3)"},{"name":"tV_delay","data_type":"Float64","null_value":0,"comment":"Time delay for reconnection after voltage ride-through disconnection","valid_range":{"max":null,"min":0}},{"name":"VES_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Min and max voltage for entering service (VES_min,VES_max)"},{"name":"FRT_pnts","data_type":"NamedTuple{(:frt1, :frt2, :frt3, :frt4), Tuple{Float64, Float64, Float64, Float64}}","null_value":"(frt1=0.0, frt2=0.0, frt3=0.0, frt4=0.0)","comment":"Frequency ride through v points (frt1,frt2,frt3,frt4)"},{"name":"TFRT_pnts","data_type":"NamedTuple{(:tfrt1, :tfrt2), Tuple{Float64, Float64}}","null_value":"(tfrt1=0.0, tfrt2=0.0)","comment":"Frequency ride through time points (tfrt1,tfrt2)"},{"name":"tF_delay","data_type":"Float64","null_value":0,"comment":"Time delay for reconnection after frequency ride-through disconnection","valid_range":{"max":null,"min":0}},{"name":"FES_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Min and max frequency for entering service (FES_min,FES_max)"},{"name":"Pfa_ref","default":"0.0","data_type":"Float64","null_value":0,"comment":"Reference power factor","valid_range":{"max":null,"min":0}},{"name":"Q_ref","default":"0.0","data_type":"Float64","null_value":0,"comment":"Reference reactive power, in pu","valid_range":{"max":null,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference active power, in pu","valid_range":{"max":null,"min":0}},{"name":"base_power","default":"100.0","data_type":"Float64","null_value":0,"comment":"Base power"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of GenericDER depend on the Flags","internal_default":"PowerSystems.get_GenericDER_states(Qref_Flag)[1]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The states of GenericDER depend on the Flags","internal_default":"PowerSystems.get_GenericDER_states(Qref_Flag)[2]"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of a Generic Distributed Energy Resource Model. Based on https://scholarspace.manoa.hawaii.edu/bitstream/10125/70994/0304.pdf","struct_name":"GenericDER","supertype":"DynamicInjection"},{"fields":[{"name":"device"},{"name":"droop","data_type":"Float64","valid_range":{"max":null,"min":0}},{"name":"participation_factor","data_type":"UpDown"},{"name":"reserve_limit_dn","data_type":"Float64","valid_range":{"max":null,"min":0}},{"name":"reserve_limit_up","data_type":"Float64","valid_range":{"max":null,"min":0}},{"name":"inertia","data_type":"Float64","valid_range":{"max":null,"min":0}},{"name":"cost","data_type":"Float64","valid_range":{"max":null,"min":0}},{"name":"time_series_container","data_type":"InfrastructureSystems.TimeSeriesContainer"},{"name":"internal","data_type":"InfrastructureSystems.InfrastructureSystemsInternal"}],"struct_name":"RegulationDevice"}]} \ No newline at end of file diff --git a/previews/PR360/tutorials/power-simulations-dynamics.log b/previews/PR360/tutorials/power-simulations-dynamics.log new file mode 100644 index 000000000..e69de29bb diff --git a/previews/PR360/tutorials/threebus_sys.json b/previews/PR360/tutorials/threebus_sys.json new file mode 100644 index 000000000..59dd85449 --- /dev/null +++ b/previews/PR360/tutorials/threebus_sys.json @@ -0,0 +1 @@ +{"internal":{"uuid":{"value":"b66526ea-8fad-44bc-a73e-85c8b23f2e66"},"ext":{},"units_info":null},"data":{"time_series_in_memory":false,"masked_components":[],"version_info":{"julia_version":"1.10.0","package_info":"Status `~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/docs/Manifest.toml`\n [47edcb42] ADTypes v0.2.6\n [a4c015fc] ANSIColoredPrinters v0.0.1\n [1520ce14] AbstractTrees v0.4.4\n⌅ [79e6a3ab] Adapt v3.7.2\n [ec485272] ArnoldiMethod v0.2.0\n [4fba245c] ArrayInterface v7.7.0\n [4c555306] ArrayLayouts v1.4.5\n [d1d4a3ce] BitFlags v0.1.8\n [62783981] BitTwiddlingConvenienceFunctions v0.1.5\n [a74b3585] Blosc v0.7.3\n [fa961155] CEnum v0.5.0\n [2a0fbf3d] CPUSummary v0.2.4\n [336ed68f] CSV v0.10.12\n [fb6a15b2] CloseOpenIntervals v0.1.12\n [944b1d66] CodecZlib v0.7.3\n [35d6a980] ColorSchemes v3.24.0\n [3da002f7] ColorTypes v0.11.4\n [c3611d14] ColorVectorSpace v0.10.0\n [5ae59095] Colors v0.12.10\n [38540f10] CommonSolve v0.2.4\n [bbf7d656] CommonSubexpressions v0.3.0\n [34da2185] Compat v4.10.1\n [2569d6c7] ConcreteStructs v0.2.3\n [f0e56b4a] ConcurrentUtilities v2.3.0\n [187b0558] ConstructionBase v1.5.4\n [d38c429a] Contour v0.6.2\n [adafc99b] CpuId v0.3.1\n [a8cc5b0e] Crayons v4.1.1\n [9a962f9c] DataAPI v1.15.0\n [a93c6f00] DataFrames v1.6.1\n [864edb3b] DataStructures v0.18.16\n [e2d170a0] DataValueInterfaces v1.0.0\n [8bb1440f] DelimitedFiles v1.9.1\n [2b5f629d] DiffEqBase v6.145.6\n [163ba53b] DiffResults v1.1.0\n [b552c78f] DiffRules v1.15.1\n [b4f34e82] Distances v0.10.11\n [ffbed154] DocStringExtensions v0.9.3\n⌅ [e30172f5] Documenter v0.27.25\n [35a29f4d] DocumenterTools v0.1.18\n [4e289a0a] EnumX v1.0.4\n [f151be2c] EnzymeCore v0.6.5\n [460bff9d] ExceptionUnwrapping v0.1.10\n [d4d017d3] ExponentialUtilities v1.25.0\n [e2ba6199] ExprTools v0.1.10\n [c87230d0] FFMPEG v0.4.1\n [7034ab61] FastBroadcast v0.2.8\n [9aa1b823] FastClosures v0.3.2\n [29a986be] FastLapackInterface v2.0.0\n [48062228] FilePathsBase v0.9.21\n [1a297f60] FillArrays v1.9.3\n [6a86dc24] FiniteDiff v2.22.0\n [53c48c17] FixedPointNumbers v0.8.4\n [59287772] Formatting v0.4.2\n [f6369f11] ForwardDiff v0.10.36\n [069b7b12] FunctionWrappers v1.1.3\n [77dc65aa] FunctionWrappersWrappers v0.1.3\n⌃ [46192b85] GPUArraysCore v0.1.5\n⌅ [28b8d3ca] GR v0.72.10\n [c145ed77] GenericSchur v0.5.3\n [86223c79] Graphs v1.9.0\n [42e2da0e] Grisu v1.0.2\n [708ec375] Gumbo v0.8.2\n [c8ec2601] H5Zblosc v0.1.2\n [f67ccb44] HDF5 v0.17.1\n [cd3eb016] HTTP v1.10.1\n [3e5b6fbb] HostCPUFeatures v0.1.16\n [b5f81e59] IOCapture v0.2.3\n [615f187c] IfElse v0.1.1\n [d25df0c9] Inflate v0.1.4\n [2cd47ed4] InfrastructureSystems v1.22.1\n [842dd82b] InlineStrings v1.4.0\n [41ab1584] InvertedIndices v1.3.0\n [92d709cd] IrrationalConstants v0.2.2\n [82899510] IteratorInterfaceExtensions v1.0.0\n [1019f520] JLFzf v0.1.7\n [692b3bcd] JLLWrappers v1.5.0\n [682c06a0] JSON v0.21.4\n [0f8b85d8] JSON3 v1.14.0\n [ef3ab10e] KLU v0.4.1\n [ba0b0d4f] Krylov v0.9.5\n [b964fa9f] LaTeXStrings v1.3.1\n [23fbe1c1] Latexify v0.16.1\n [10f19ff3] LayoutPointers v0.1.15\n [50d2b5c4] Lazy v0.15.1\n [5078a376] LazyArrays v1.8.3\n [1d6d02ad] LeftChildRightSiblingTrees v0.2.0\n [d3d80556] LineSearches v7.2.0\n [7ed4a6bd] LinearSolve v2.22.0\n [2ab3a3ac] LogExpFunctions v0.3.26\n [e6f89c97] LoggingExtras v1.0.3\n [bdcacae8] LoopVectorization v0.12.166\n [33e6dc65] MKL v0.6.2\n [3da0fdf6] MPIPreferences v0.1.10\n [1914dd2f] MacroTools v0.5.12\n [d125e4d3] ManualMemory v0.1.8\n [299715c1] MarchingCubes v0.1.9\n [a3b82374] MatrixFactorizations v2.1.0\n [bb5d69b7] MaybeInplace v0.1.1\n [739be429] MbedTLS v1.1.9\n [442fdcdd] Measures v0.3.2\n [e1d29d7a] Missings v1.1.0\n [46d2c3a1] MuladdMacro v0.2.4\n [ffc61752] Mustache v1.0.19\n [d41bc354] NLSolversBase v7.8.3\n [2774e3e8] NLsolve v4.5.1\n [77ba4419] NaNMath v1.0.2\n [8913a72c] NonlinearSolve v3.4.0\n [6fe1bfb0] OffsetArrays v1.13.0\n [4d8831e6] OpenSSL v1.4.1\n [bac558e1] OrderedCollections v1.6.3\n [1dea7af3] OrdinaryDiffEq v6.68.0\n [65ce6f38] PackageExtensionCompat v1.0.2\n [d96e819e] Parameters v0.12.3\n [46dd5b70] Pardiso v0.5.4\n [69de0a69] Parsers v2.8.1\n [b98c9c47] Pipe v1.3.0\n [ccf2f8ad] PlotThemes v3.1.0\n [995b91a9] PlotUtils v1.4.0\n [91a5bcdd] Plots v1.39.0\n [f517fe37] Polyester v0.7.9\n [1d0040c9] PolyesterWeave v0.2.1\n [2dfb63ee] PooledArrays v1.4.3\n [dd99e9e3] PowerFlowData v1.5.0\n [94fada2c] PowerFlows v0.6.1\n [bed98974] PowerNetworkMatrices v0.9.6\n [398b2ede] PowerSimulationsDynamics v0.13.0 `~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl`\n [f00506e0] PowerSystemCaseBuilder v1.2.2\n [bcd98974] PowerSystems v3.2.0\n [d236fae5] PreallocationTools v0.4.17\n [aea7be01] PrecompileTools v1.2.0\n [21216c6a] Preferences v1.4.1\n [08abe8d2] PrettyTables v2.3.1\n [33c8b6b6] ProgressLogging v0.1.4\n [3cdcf5f2] RecipesBase v1.3.4\n [01d81517] RecipesPipeline v0.6.12\n [731186ca] RecursiveArrayTools v3.4.0\n [f2c3362d] RecursiveFactorization v0.2.21\n [189a3867] Reexport v1.2.2\n [05181044] RelocatableFolders v1.0.1\n [ae029012] Requires v1.3.0\n [7e49a35a] RuntimeGeneratedFunctions v0.5.12\n [94e857df] SIMDTypes v0.1.0\n [476501e8] SLEEFPirates v0.6.42\n [322a6be2] Sass v0.2.0\n [0bca4576] SciMLBase v2.16.3\n [c0aeaf25] SciMLOperators v0.3.7\n [6c6a2e73] Scratch v1.2.1\n [91c51154] SentinelArrays v1.4.1\n [efcf1570] Setfield v1.1.1\n [992d4aef] Showoff v1.0.3\n [777ac1f9] SimpleBufferStream v1.1.0\n [727e6d20] SimpleNonlinearSolve v1.2.0\n [699a6c99] SimpleTraits v0.9.4\n [ce78b400] SimpleUnPack v1.1.0\n [a2af1166] SortingAlgorithms v1.2.1\n [47a9eef4] SparseDiffTools v2.15.0\n [e56a9233] Sparspak v0.3.9\n [276daf66] SpecialFunctions v2.3.1\n [aedffcd0] Static v0.8.8\n [0d7ed370] StaticArrayInterface v1.5.0\n [90137ffa] StaticArrays v1.9.0\n [1e83bf80] StaticArraysCore v1.4.2\n [82ae8749] StatsAPI v1.7.0\n [2913bbd2] StatsBase v0.34.2\n [7792a7ef] StrideArraysCore v0.5.2\n [69024149] StringEncodings v0.3.7\n [892a3eda] StringManipulation v0.3.4\n [856f2bd8] StructTypes v1.10.0\n [c3572dad] Sundials v4.23.1\n [2efcf032] SymbolicIndexingInterface v0.3.3\n [3783bdb8] TableTraits v1.0.1\n [bd369af6] Tables v1.11.1\n [62fd8b95] TensorCore v0.1.1\n [5d786b92] TerminalLoggers v0.1.7\n [8290d209] ThreadingUtilities v0.5.2\n⌅ [9e3dc215] TimeSeries v0.23.2\n [a759f4b9] TimerOutputs v0.5.23\n [3bb67fe8] TranscodingStreams v0.10.2\n [d5829a12] TriangularSolve v0.1.20\n [410a4b4d] Tricks v0.1.8\n [781d530d] TruncatedStacktraces v1.4.0\n [5c2747f8] URIs v1.5.1\n [3a884ed6] UnPack v1.0.2\n [1cfade01] UnicodeFun v0.4.1\n [b8865327] UnicodePlots v3.6.3\n [1986cc42] Unitful v1.19.0\n [45397f5d] UnitfulLatexify v1.6.3\n [41fe7b60] Unzip v0.2.0\n [3d5dd08c] VectorizationBase v0.21.65\n [19fa3120] VertexSafeGraphs v0.2.0\n [ea10d353] WeakRefStrings v1.4.2\n [76eceee3] WorkerUtilities v1.6.1\n [ddb6d928] YAML v0.4.9\n [0b7ba130] Blosc_jll v1.21.5+0\n [6e34b625] Bzip2_jll v1.0.8+0\n [83423d85] Cairo_jll v1.16.1+1\n [2702e6a9] EpollShim_jll v0.0.20230411+0\n [2e619515] Expat_jll v2.5.0+0\n⌃ [b22a6f82] FFMPEG_jll v4.4.2+2\n [a3f928ae] Fontconfig_jll v2.13.93+0\n [d7e528f0] FreeType2_jll v2.13.1+0\n [559328eb] FriBidi_jll v1.0.10+0\n [0656b61e] GLFW_jll v3.3.9+0\n⌅ [d2c73de3] GR_jll v0.72.10+0\n [78b55507] Gettext_jll v0.21.0+0\n [7746bdde] Glib_jll v2.76.5+0\n [3b182d85] Graphite2_jll v1.3.14+0\n [528830af] Gumbo_jll v0.10.2+0\n⌃ [0234f1f7] HDF5_jll v1.12.2+2\n [2e76f6c2] HarfBuzz_jll v2.8.1+1\n⌅ [1d5cc7b8] IntelOpenMP_jll v2023.2.0+0\n [aacddb02] JpegTurbo_jll v3.0.1+0\n [c1c5ebd0] LAME_jll v3.100.1+0\n [88015f11] LERC_jll v3.0.0+1\n [1d63c593] LLVMOpenMP_jll v15.0.7+0\n [dd4b983a] LZO_jll v2.10.1+0\n⌅ [e9f186c6] Libffi_jll v3.2.2+1\n [d4300ac3] Libgcrypt_jll v1.8.7+0\n [7e76a0d4] Libglvnd_jll v1.6.0+0\n [7add5ba3] Libgpg_error_jll v1.42.0+0\n [94ce4f54] Libiconv_jll v1.17.0+0\n [4b2f31a3] Libmount_jll v2.35.0+0\n⌅ [89763e89] Libtiff_jll v4.5.1+1\n [38a345b3] Libuuid_jll v2.36.0+0\n [5ced341a] Lz4_jll v1.9.4+0\n⌅ [856f044c] MKL_jll v2022.2.0+0\n [e7412a2a] Ogg_jll v1.3.5+1\n⌅ [9bd350c2] OpenSSH_jll v8.9.0+1\n⌅ [458c3c95] OpenSSL_jll v1.1.23+0\n [efe28fd5] OpenSpecFun_jll v0.5.5+0\n [91d4177d] Opus_jll v1.3.2+0\n [30392449] Pixman_jll v0.42.2+0\n⌃ [c0090381] Qt6Base_jll v6.5.2+2\n⌅ [fb77eaff] Sundials_jll v5.2.2+0\n [a44049a8] Vulkan_Loader_jll v1.3.243+0\n [a2964d1f] Wayland_jll v1.21.0+1\n [2381bf8a] Wayland_protocols_jll v1.31.0+0\n [02c8fc9c] XML2_jll v2.12.2+0\n [aed1982a] XSLT_jll v1.1.34+0\n [ffd25f8a] XZ_jll v5.4.5+0\n [f67eecfb] Xorg_libICE_jll v1.0.10+1\n [c834827a] Xorg_libSM_jll v1.2.3+0\n [4f6342f7] Xorg_libX11_jll v1.8.6+0\n [0c0b7dd1] Xorg_libXau_jll v1.0.11+0\n [935fb764] Xorg_libXcursor_jll v1.2.0+4\n [a3789734] Xorg_libXdmcp_jll v1.1.4+0\n [1082639a] Xorg_libXext_jll v1.3.4+4\n [d091e8ba] Xorg_libXfixes_jll v5.0.3+4\n [a51aa0fd] Xorg_libXi_jll v1.7.10+4\n [d1454406] Xorg_libXinerama_jll v1.1.4+4\n [ec84b674] Xorg_libXrandr_jll v1.5.2+4\n [ea2f1a96] Xorg_libXrender_jll v0.9.10+4\n [14d82f49] Xorg_libpthread_stubs_jll v0.1.1+0\n [c7cfdc94] Xorg_libxcb_jll v1.15.0+0\n [cc61e674] Xorg_libxkbfile_jll v1.1.2+0\n [e920d4aa] Xorg_xcb_util_cursor_jll v0.1.4+0\n [12413925] Xorg_xcb_util_image_jll v0.4.0+1\n [2def613f] Xorg_xcb_util_jll v0.4.0+1\n [975044d2] Xorg_xcb_util_keysyms_jll v0.4.0+1\n [0d47668e] Xorg_xcb_util_renderutil_jll v0.3.9+1\n [c22f9ab0] Xorg_xcb_util_wm_jll v0.4.1+1\n [35661453] Xorg_xkbcomp_jll v1.4.6+0\n [33bec58e] Xorg_xkeyboard_config_jll v2.39.0+0\n [c5fb5394] Xorg_xtrans_jll v1.5.0+0\n [3161d3a3] Zstd_jll v1.5.5+0\n [35ca27e7] eudev_jll v3.2.9+0\n [214eeab7] fzf_jll v0.43.0+0\n [1a1c6b14] gperf_jll v3.1.1+0\n [a4ae2306] libaom_jll v3.4.0+0\n [0ac62f75] libass_jll v0.15.1+0\n [2db6ffa8] libevdev_jll v1.11.0+0\n [f638f0a6] libfdk_aac_jll v2.0.2+0\n [36db933b] libinput_jll v1.18.0+0\n [b53b4c65] libpng_jll v1.6.40+0\n [47bcb7c8] libsass_jll v3.6.4+0\n [f27f6e37] libvorbis_jll v1.3.7+1\n [009596ad] mtdev_jll v1.1.6+0\n [1270edf5] x264_jll v2021.5.5+0\n [dfaa095f] x265_jll v3.5.0+0\n [d8fb68d0] xkbcommon_jll v1.4.1+1\n [0dad84c5] ArgTools v1.1.1\n [56f22d72] Artifacts\n [2a0f44e3] Base64\n [ade2ca70] Dates\n [8ba89e20] Distributed\n [f43a241f] Downloads v1.6.0\n [7b1f6079] FileWatching\n [9fa8497b] Future\n [b77e0a4c] InteractiveUtils\n [4af54fe1] LazyArtifacts\n [b27032c2] LibCURL v0.6.4\n [76f85450] LibGit2\n [8f399da3] Libdl\n [37e2e46d] LinearAlgebra\n [56ddb016] Logging\n [d6f4376e] Markdown\n [a63ad114] Mmap\n [ca575930] NetworkOptions v1.2.0\n [44cfe95a] Pkg v1.10.0\n [de0858da] Printf\n [3fa0cd96] REPL\n [9a3f8284] Random\n [ea8e919c] SHA v0.7.0\n [9e88b42a] Serialization\n [1a1011a3] SharedArrays\n [6462fe0b] Sockets\n [2f01184e] SparseArrays v1.10.0\n [10745b16] Statistics v1.10.0\n [4607b0f0] SuiteSparse\n [fa267f1f] TOML v1.0.3\n [a4e569a6] Tar v1.10.0\n [8dfed614] Test\n [cf7118a7] UUIDs\n [4ec0a83e] Unicode\n [e66e0078] CompilerSupportLibraries_jll v1.0.5+1\n [deac9b47] LibCURL_jll v8.4.0+0\n [e37daf67] LibGit2_jll v1.6.4+0\n [29816b5a] LibSSH2_jll v1.11.0+1\n [c8ffd9c3] MbedTLS_jll v2.28.2+1\n [14a3606d] MozillaCACerts_jll v2023.1.10\n [4536629a] OpenBLAS_jll v0.3.23+2\n [05823500] OpenLibm_jll v0.8.1+2\n [efcefdf7] PCRE2_jll v10.42.0+1\n [bea87d4a] SuiteSparse_jll v7.2.1+1\n [83775a58] Zlib_jll v1.2.13+1\n [8e850b90] libblastrampoline_jll v5.8.0+1\n [8e850ede] nghttp2_jll v1.52.0+1\n [3f19e933] p7zip_jll v17.4.0+2\nInfo 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`\n"},"internal":{"uuid":{"value":"775e8f25-c0d2-4a59-9f03-0393b3065829"},"ext":{},"units_info":null},"time_series_compression_enabled":false,"components":[{"base_power":100.0,"services":[],"bus":{"value":"bcd48030-585c-4b13-944d-29f092ce38b6"},"max_constant_active_power":0.5,"available":true,"time_series_container":[],"name":"load1011","max_current_active_power":0.0,"constant_active_power":0.5,"dynamic_injector":null,"__metadata__":{"module":"PowerSystems","type":"StandardLoad"},"current_active_power":0.0,"current_reactive_power":0.0,"internal":{"uuid":{"value":"b01243b0-59ce-4c24-8c7c-154e275f72c1"},"ext":null,"units_info":null},"ext":{},"max_constant_reactive_power":0.1,"max_current_reactive_power":0.0,"impedance_reactive_power":0.0,"impedance_active_power":0.0,"max_impedance_active_power":0.0,"constant_reactive_power":0.1,"max_impedance_reactive_power":0.0},{"base_power":100.0,"services":[],"bus":{"value":"e228e83a-6df9-4cac-a58f-02d2fb7bad14"},"max_constant_active_power":0.3,"available":true,"time_series_container":[],"name":"load1031","max_current_active_power":0.0,"constant_active_power":0.3,"dynamic_injector":null,"__metadata__":{"module":"PowerSystems","type":"StandardLoad"},"current_active_power":0.0,"current_reactive_power":0.0,"internal":{"uuid":{"value":"7e23dbc8-470d-4fa3-a021-f357f21fec56"},"ext":null,"units_info":null},"ext":{},"max_constant_reactive_power":0.1,"max_current_reactive_power":0.0,"impedance_reactive_power":0.0,"impedance_active_power":0.0,"max_impedance_active_power":0.0,"constant_reactive_power":0.1,"max_impedance_reactive_power":0.0},{"base_power":100.0,"services":[],"bus":{"value":"006b50a9-1265-4e4a-be16-5e3edc861ee6"},"max_constant_active_power":1.0,"available":true,"time_series_container":[],"name":"load1021","max_current_active_power":0.0,"constant_active_power":1.0,"dynamic_injector":null,"__metadata__":{"module":"PowerSystems","type":"StandardLoad"},"current_active_power":0.0,"current_reactive_power":0.0,"internal":{"uuid":{"value":"38de5b50-be72-4eed-a501-d1c7531569b7"},"ext":null,"units_info":null},"ext":{},"max_constant_reactive_power":0.3,"max_current_reactive_power":0.0,"impedance_reactive_power":0.0,"impedance_active_power":0.0,"max_impedance_active_power":0.0,"constant_reactive_power":0.3,"max_impedance_reactive_power":0.0},{"internal_voltage":1.0,"services":[],"bus":{"value":"6185e308-980c-430a-ab02-cb3ef9eaaba2"},"available":true,"name":"InfBus","internal_angle":0.0,"active_power":0.0,"dynamic_injector":null,"__metadata__":{"module":"PowerSystems","type":"Source"},"internal":{"uuid":{"value":"02d5e948-0a05-4220-bece-afeb68d92cec"},"ext":null,"units_info":null},"ext":{},"X_th":5.0e-6,"R_th":0.0,"reactive_power":0.0},{"base_power":100.0,"shaft":{"internal":{"uuid":{"value":"bda749ae-7759-4f22-a548-e38674fc36fc"},"ext":null,"units_info":null},"n_states":2,"ext":{},"D":0.0,"states":["δ","ω"],"H":3.01,"__metadata__":{"module":"PowerSystems","type":"SingleMass"}},"states":["eq_p","ed_p","δ","ω","Vf","Vr1","Vr2","Vm"],"name":"generator-102-1","n_states":8,"ω_ref":1.0,"__metadata__":{"parameters":["OneDOneQMachine","SingleMass","AVRTypeI","TGFixed","PSSFixed"],"module":"PowerSystems","type":"DynamicGenerator"},"avr":{"Ta":0.2,"Te":0.314,"states_types":["Differential","Differential","Differential","Differential"],"__metadata__":{"module":"PowerSystems","type":"AVRTypeI"},"internal":{"uuid":{"value":"26b3c63f-11bd-4cbf-b1ee-417137ba1eee"},"ext":null,"units_info":null},"Ke":0.01,"ext":{},"Kf":0.063,"V_ref":1.0,"states":["Vf","Vr1","Vr2","Vm"],"Ae":0.0039,"n_states":4,"Tf":0.35,"Tr":0.001,"Va_lim":{"min":-5.0,"max":5.0},"Be":1.555,"Ka":20.0},"internal":{"uuid":{"value":"bef57db0-250c-47e5-9b30-d48b178d9c06"},"ext":null,"units_info":null},"ext":{},"machine":{"internal":{"uuid":{"value":"d1e00908-06ad-44f7-ade5-880e480b9a10"},"ext":null,"units_info":null},"Xq":1.2578,"ext":{},"states":["eq_p","ed_p"],"Tq0_p":0.6,"n_states":2,"Xd":1.3125,"Xd_p":0.1813,"Xq_p":0.25,"Td0_p":5.89,"R":0.0,"__metadata__":{"module":"PowerSystems","type":"OneDOneQMachine"}},"pss":{"V_pss":0.0,"internal":{"uuid":{"value":"0d0ab696-3426-4269-8068-19f6d70f23ca"},"ext":null,"units_info":null},"n_states":0,"ext":{},"states":[],"__metadata__":{"module":"PowerSystems","type":"PSSFixed"}},"prime_mover":{"P_ref":1.0,"internal":{"uuid":{"value":"2136c5a4-8b43-4224-b5ec-7d498accceb2"},"ext":null,"units_info":null},"efficiency":1.0,"n_states":0,"ext":{},"states":[],"__metadata__":{"module":"PowerSystems","type":"TGFixed"}}},{"base_power":100.0,"prime_mover_type":"OT","rating":3.333526661060325,"services":[],"bus":{"value":"006b50a9-1265-4e4a-be16-5e3edc861ee6"},"available":true,"time_series_container":[],"name":"generator-102-1","status":true,"active_power":0.7,"dynamic_injector":{"value":"bef57db0-250c-47e5-9b30-d48b178d9c06"},"__metadata__":{"module":"PowerSystems","type":"ThermalStandard"},"fuel":"OTHER","internal":{"uuid":{"value":"f35e4f7d-874e-4431-8efc-e9a81fb9b6de"},"ext":null,"units_info":null},"reactive_power_limits":{"min":-1.0,"max":1.0},"ext":{"z_source":{"x":1,"r":0}},"operation_cost":{"start_up":0.0,"fixed":0.0,"shut_down":0.0,"variable":{"cost":[0.0,1.0]},"__metadata__":{"module":"PowerSystems","type":"ThreePartCost"}},"time_limits":null,"must_run":false,"ramp_limits":{"up":3.18,"down":3.18},"time_at_status":10000.0,"active_power_limits":{"min":0.0,"max":3.18},"reactive_power":0.0},{"base_power":100.0,"prime_mover_type":"OT","rating":3.333526661060325,"services":[],"bus":{"value":"e228e83a-6df9-4cac-a58f-02d2fb7bad14"},"available":true,"time_series_container":[],"name":"generator-103-1","status":true,"active_power":0.8,"dynamic_injector":{"value":"e866778d-ffd6-4996-a0bd-f1f58467a631"},"__metadata__":{"module":"PowerSystems","type":"ThermalStandard"},"fuel":"OTHER","internal":{"uuid":{"value":"f3e2a1b0-474f-46ea-93b8-9de20a6f50ac"},"ext":null,"units_info":null},"reactive_power_limits":{"min":-1.0,"max":1.0},"ext":{"z_source":{"x":1,"r":0}},"operation_cost":{"start_up":0.0,"fixed":0.0,"shut_down":0.0,"variable":{"cost":[0.0,1.0]},"__metadata__":{"module":"PowerSystems","type":"ThreePartCost"}},"time_limits":null,"must_run":false,"ramp_limits":{"up":3.18,"down":3.18},"time_at_status":10000.0,"active_power_limits":{"min":0.0,"max":3.18},"reactive_power":0.0},{"internal":{"uuid":{"value":"670c178f-8b85-4311-b8f5-776fb757a5ac"},"ext":null,"units_info":null},"to":{"value":"e228e83a-6df9-4cac-a58f-02d2fb7bad14"},"from":{"value":"bcd48030-585c-4b13-944d-29f092ce38b6"},"__metadata__":{"module":"PowerSystems","type":"Arc"}},{"internal":{"uuid":{"value":"b04bd5f7-7c4f-4a8a-8ae9-5bd9b3308796"},"ext":null,"units_info":null},"to":{"value":"006b50a9-1265-4e4a-be16-5e3edc861ee6"},"from":{"value":"bcd48030-585c-4b13-944d-29f092ce38b6"},"__metadata__":{"module":"PowerSystems","type":"Arc"}},{"internal":{"uuid":{"value":"142ebf08-c205-4b2b-9aa4-82bb48e6b4a5"},"ext":null,"units_info":null},"to":{"value":"e228e83a-6df9-4cac-a58f-02d2fb7bad14"},"from":{"value":"006b50a9-1265-4e4a-be16-5e3edc861ee6"},"__metadata__":{"module":"PowerSystems","type":"Arc"}},{"base_power":100.0,"filter":{"rg":0.01,"cf":0.074,"n_states":6,"ext":{},"lf":0.08,"lg":0.2,"states":["ir_cnv","ii_cnv","vr_filter","vi_filter","ir_filter","ii_filter"],"rf":0.003,"__metadata__":{"module":"PowerSystems","type":"LCLFilter"}},"states":["θ_oc","ω_oc","q_oc","ξd_ic","ξq_ic","γd_ic","γq_ic","ϕd_ic","ϕq_ic","vd_pll","vq_pll","ε_pll","θ_pll","ir_cnv","ii_cnv","vr_filter","vi_filter","ir_filter","ii_filter"],"dc_source":{"__metadata__":{"module":"PowerSystems","type":"FixedDCSource"},"internal":{"uuid":{"value":"d43acd79-8ae1-42c9-9ffd-d1e990c99de5"},"ext":null,"units_info":null},"n_states":0,"ext":{},"states":[],"voltage":600.0},"name":"generator-103-1","converter":{"rated_voltage":138.0,"n_states":0,"ext":{},"rated_current":100.0,"states":[],"__metadata__":{"module":"PowerSystems","type":"AverageConverter"}},"n_states":19,"ω_ref":1.0,"__metadata__":{"parameters":["AverageConverter","OuterControl","VoltageModeControl","FixedDCSource","KauraPLL","LCLFilter","Nothing"],"module":"PowerSystems","type":"DynamicInverter"},"internal":{"uuid":{"value":"e866778d-ffd6-4996-a0bd-f1f58467a631"},"ext":null,"units_info":null},"ext":{},"outer_control":{"active_power_control":{"__metadata__":{"module":"PowerSystems","type":"VirtualInertia"},"P_ref":1.0,"kω":20.0,"n_states":2,"ext":{},"states":["θ_oc","ω_oc"],"kd":400.0,"Ta":2.0},"reactive_power_control":{"kq":0.2,"n_states":1,"ext":{},"V_ref":1.0,"ωf":1000.0,"states":["q_oc"],"__metadata__":{"module":"PowerSystems","type":"ReactivePowerDroop"}},"n_states":3,"ext":{},"states":["θ_oc","ω_oc","q_oc"],"__metadata__":{"parameters":["VirtualInertia","ReactivePowerDroop"],"module":"PowerSystems","type":"OuterControl"}},"freq_estimator":{"ω_lp":500.0,"n_states":4,"ki_pll":4.69,"ext":{},"kp_pll":0.084,"states":["vd_pll","vq_pll","ε_pll","θ_pll"],"__metadata__":{"module":"PowerSystems","type":"KauraPLL"}},"inner_control":{"rv":0.0,"lv":0.2,"ωad":50.0,"kpc":1.27,"ext":{},"states":["ξd_ic","ξq_ic","γd_ic","γq_ic","ϕd_ic","ϕq_ic"],"kffi":0.0,"kffv":0.0,"n_states":6,"kpv":0.59,"kiv":736.0,"kad":0.2,"kic":14.3,"__metadata__":{"module":"PowerSystems","type":"VoltageModeControl"}},"limiter":null},{"number":103,"base_voltage":138.0,"bustype":"PV","angle":0.0,"name":"BUS 3","magnitude":1.0059,"__metadata__":{"module":"PowerSystems","type":"ACBus"},"internal":{"uuid":{"value":"e228e83a-6df9-4cac-a58f-02d2fb7bad14"},"ext":null,"units_info":null},"area":{"value":"095d04df-b67c-4d5a-bc56-6a79f79cb626"},"ext":{},"voltage_limits":{"min":0.9,"max":1.1},"load_zone":{"value":"1e0879e5-184f-4ccf-aac3-adaa95fe6dc8"}},{"number":101,"base_voltage":138.0,"bustype":"REF","angle":0.0,"name":"BUS 1","magnitude":1.02,"__metadata__":{"module":"PowerSystems","type":"ACBus"},"internal":{"uuid":{"value":"bcd48030-585c-4b13-944d-29f092ce38b6"},"ext":null,"units_info":null},"area":{"value":"095d04df-b67c-4d5a-bc56-6a79f79cb626"},"ext":{},"voltage_limits":{"min":0.9,"max":1.1},"load_zone":{"value":"1e0879e5-184f-4ccf-aac3-adaa95fe6dc8"}},{"number":102,"base_voltage":138.0,"bustype":"PV","angle":0.0,"name":"BUS 2","magnitude":1.0142,"__metadata__":{"module":"PowerSystems","type":"ACBus"},"internal":{"uuid":{"value":"006b50a9-1265-4e4a-be16-5e3edc861ee6"},"ext":null,"units_info":null},"area":{"value":"095d04df-b67c-4d5a-bc56-6a79f79cb626"},"ext":{},"voltage_limits":{"min":0.9,"max":1.1},"load_zone":{"value":"1e0879e5-184f-4ccf-aac3-adaa95fe6dc8"}},{"__metadata__":{"module":"PowerSystems","type":"LoadZone"},"name":"1","internal":{"uuid":{"value":"1e0879e5-184f-4ccf-aac3-adaa95fe6dc8"},"ext":null,"units_info":null},"peak_active_power":1.8,"peak_reactive_power":0.5,"time_series_container":[]},{"services":[],"x":0.12,"b":{"from":0.1,"to":0.1},"r":0.01,"rate":2.5,"available":true,"time_series_container":[],"name":"BUS 1-BUS 3-i_1","reactive_power_flow":0.0,"arc":{"value":"670c178f-8b85-4311-b8f5-776fb757a5ac"},"__metadata__":{"module":"PowerSystems","type":"Line"},"internal":{"uuid":{"value":"50989f26-8ee6-4e6c-8e71-77ad1ded3cdd"},"ext":null,"units_info":null},"ext":{},"active_power_flow":0.0,"angle_limits":{"min":-1.0472,"max":1.0472}},{"services":[],"x":0.12,"b":{"from":0.1,"to":0.1},"r":0.01,"rate":2.5,"available":true,"time_series_container":[],"name":"BUS 1-BUS 2-i_1","reactive_power_flow":0.0,"arc":{"value":"b04bd5f7-7c4f-4a8a-8ae9-5bd9b3308796"},"__metadata__":{"module":"PowerSystems","type":"Line"},"internal":{"uuid":{"value":"0435117c-8720-4b20-b9d3-75ac9a5d7142"},"ext":null,"units_info":null},"ext":{},"active_power_flow":0.0,"angle_limits":{"min":-1.0472,"max":1.0472}},{"services":[],"x":0.9,"b":{"from":0.5,"to":0.5},"r":0.02,"rate":2.5,"available":true,"time_series_container":[],"name":"BUS 2-BUS 3-i_1","reactive_power_flow":0.0,"arc":{"value":"142ebf08-c205-4b2b-9aa4-82bb48e6b4a5"},"__metadata__":{"module":"PowerSystems","type":"Line"},"internal":{"uuid":{"value":"59541fa5-7fac-43c8-bfec-9c0770806db5"},"ext":null,"units_info":null},"ext":{},"active_power_flow":0.0,"angle_limits":{"min":-1.0472,"max":1.0472}},{"load_response":0.0,"name":"1","__metadata__":{"module":"PowerSystems","type":"Area"},"internal":{"uuid":{"value":"095d04df-b67c-4d5a-bc56-6a79f79cb626"},"ext":null,"units_info":null},"peak_active_power":0.0,"peak_reactive_power":0.0,"time_series_container":[]}],"validation_descriptor_file":"threebus_sys_validation_descriptors.json","time_series_params":{"__metadata__":{"module":"InfrastructureSystems","type":"TimeSeriesParameters"},"resolution":{"value":0,"type":"Minute"},"forecast_params":{"initial_timestamp":"0001-01-01T00:00:00.0","interval":{"value":0,"type":"Minute"},"horizon":0,"count":0,"__metadata__":{"module":"InfrastructureSystems","type":"ForecastParameters"}}}},"units_settings":{"base_value":100.0,"unit_system":"SYSTEM_BASE"},"frequency":60.0,"runchecks":true,"metadata":{"name":null,"description":null,"__metadata__":{"module":"PowerSystems","type":"SystemMetadata"}},"data_format_version":"3.0.0"} \ No newline at end of file diff --git a/previews/PR360/tutorials/threebus_sys_metadata.json b/previews/PR360/tutorials/threebus_sys_metadata.json new file mode 100644 index 000000000..dd7bc141c --- /dev/null +++ b/previews/PR360/tutorials/threebus_sys_metadata.json @@ -0,0 +1,50 @@ +{ + "name": "", + "description": "", + "frequency": 60, + "time_series_resolution_milliseconds": 0, + "component_counts": [ + { + "type": "ACBus", + "count": 3 + }, + { + "type": "Arc", + "count": 3 + }, + { + "type": "Area", + "count": 1 + }, + { + "type": "DynamicGenerator", + "count": 1 + }, + { + "type": "DynamicInverter", + "count": 1 + }, + { + "type": "Line", + "count": 3 + }, + { + "type": "LoadZone", + "count": 1 + }, + { + "type": "Source", + "count": 1 + }, + { + "type": "StandardLoad", + "count": 3 + }, + { + "type": "ThermalStandard", + "count": 2 + } + ], + "time_series_counts": [ + ] +} \ No newline at end of file diff --git a/previews/PR360/tutorials/threebus_sys_validation_descriptors.json b/previews/PR360/tutorials/threebus_sys_validation_descriptors.json new file mode 100644 index 000000000..e9df79ac3 --- /dev/null +++ b/previews/PR360/tutorials/threebus_sys_validation_descriptors.json @@ -0,0 +1 @@ +{"struct_validation_descriptors":[{"fields":[{"name":"variable","data_type":"VariableCost","null_value":"VariableCost((0.0, 0.0))","comment":"variable cost"},{"name":"fixed","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"fixed cost","valid_range":{"max":null,"min":0}}],"docstring":"Data Structure Operational Cost Data in two parts: fixed and variable cost.","struct_name":"TwoPartCost","supertype":"OperationalCost"},{"fields":[{"name":"variable","data_type":"VariableCost","null_value":"VariableCost((0.0, 0.0))","comment":"variable cost"},{"name":"fixed","data_type":"Float64","null_value":"0.0","comment":"fixed cost"},{"name":"start_up","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"start-up cost","valid_range":{"max":null,"min":0}},{"name":"shut_down","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"shut-down cost","valid_range":{"max":null,"min":0}}],"docstring":"Data Structure Operational Cost Data in Three parts fixed, variable cost and start - stop costs.","struct_name":"ThreePartCost","supertype":"OperationalCost"},{"fields":[{"name":"variable","default":"VariableCost((0.0, 0.0))","data_type":"VariableCost","null_value":"VariableCost((0.0, 0.0))","comment":"variable cost"},{"name":"fixed","default":"0.0","data_type":"Float64","null_value":"0.0","comment":"fixed cost"},{"name":"start_up","default":"0.0","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"start-up cost","valid_range":{"max":null,"min":0}},{"name":"shut_down","default":"0.0","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"shut-down cost","valid_range":{"max":null,"min":0}},{"name":"energy_shortage_cost","default":"0.0","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Cost incurred by the model for being short of the energy target.","valid_range":{"max":null,"min":0}},{"name":"energy_surplus_cost","default":"0.0","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Cost incurred by the model for surplus energy stored.","valid_range":{"max":null,"min":0}}],"docstring":"Data Structure for Operational Cost Data like variable cost and start - stop costs and energy storage cost.","struct_name":"StorageManagementCost","supertype":"OperationalCost"},{"fields":[{"name":"no_load","data_type":"Float64","null_value":"0.0","comment":"no load cost"},{"name":"start_up","data_type":"NamedTuple{(:hot, :warm, :cold), NTuple{3, Float64}}","null_value":"(hot = START_COST, warm = START_COST, cold = START_COST)","comment":"start-up cost at different stages of the thermal cycle. Warm is also refered as intermediate in some markets"},{"name":"shut_down","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"shut-down cost","valid_range":{"max":null,"min":0}},{"name":"variable","default":"nothing","data_type":"Union{Nothing, IS.TimeSeriesKey}","null_value":"nothing","comment":"Variable Cost TimeSeriesKey"},{"name":"ancillary_services","default":"Vector{Service}()","data_type":"Vector{Service}","null_value":"Vector{Service}()","comment":"Bids for the ancillary services"}],"docstring":"Data Structure Operational Cost to reflect market bids of energy and ancilliary services.\nCompatible with most US Market bidding mechanisms","struct_name":"MarketBidCost","supertype":"OperationalCost"},{"fields":[{"name":"variable","data_type":"VariableCost","null_value":"VariableCost((0.0, 0.0))","comment":"variable cost"},{"name":"no_load","data_type":"Float64","null_value":"0.0","comment":"no load cost"},{"name":"fixed","data_type":"Float64","null_value":"0.0","comment":"fixed cost"},{"name":"start_up","data_type":"NamedTuple{(:hot, :warm, :cold), NTuple{3, Float64}}","null_value":"(hot = START_COST, warm = START_COST, cold = START_COST)","comment":"start-up cost"},{"name":"shut_down","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"shut-down cost","valid_range":{"max":null,"min":0}}],"docstring":"Data Structure Operational Cost Data which includes fixed, variable cost, multiple start up cost and stop costs.","struct_name":"MultiStartCost","supertype":"OperationalCost"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"peak_active_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"peak_reactive_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"load_response","default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"A collection of buses for control purposes.","struct_name":"Area","supertype":"AggregationTopology"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"peak_active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"peak_reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"A collection of buses for electricity price analysis.","struct_name":"LoadZone","supertype":"AggregationTopology"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"active_power_flow_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"violation_penalty","default":"INFINITE_COST","data_type":"Float64","null_value":"0.0","comment":"Penalty for violating the flow limits in the interface"},{"name":"direction_mapping","default":"Dict{String, Int}()","data_type":"Dict{String, Int}","null_value":"Dict{String, Int}()","comment":"Map to set of multiplier to the flow in the line for cases when the line has a reverse direction with respect to the interface"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"A collection of branches that make up an interface or corridor for the transfer of power.","struct_name":"TransmissionInterface","supertype":"Service"},{"inner_constructor_check":"check_bus_params","fields":[{"name":"number","data_type":"Int","null_value":"0","comment":"number associated with the bus"},{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init","comment":"the name of the bus"},{"name":"bustype","data_type":"Union{Nothing, ACBusTypes}","null_value":"nothing","comment":"bus type"},{"name":"angle","data_type":"Union{Nothing, Float64}","null_value":"0.0","validation_action":"error","comment":"angle of the bus in radians","valid_range":{"max":1.571,"min":-1.571}},{"name":"magnitude","data_type":"Union{Nothing, Float64}","null_value":"0.0","validation_action":"warn","comment":"voltage as a multiple of basevoltage","valid_range":"voltage_limits"},{"name":"voltage_limits","data_type":"Union{Nothing, MinMax}","null_value":"(min=0.0, max=0.0)","comment":"limits on the voltage variation as multiples of basevoltage"},{"name":"base_voltage","data_type":"Union{Nothing, Float64}","null_value":"nothing","validation_action":"error","comment":"the base voltage in kV","valid_range":{"max":null,"min":0}},{"name":"area","default":"nothing","data_type":"Union{Nothing, Area}","null_value":"nothing","comment":"the area containing the bus"},{"name":"load_zone","default":"nothing","data_type":"Union{Nothing, LoadZone}","null_value":"nothing","comment":"the load zone containing the bus"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"A power-system bus.","struct_name":"ACBus","supertype":"Bus"},{"fields":[{"name":"number","data_type":"Int","null_value":"0","comment":"number associated with the DC bus"},{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init","comment":"the name of the DC bus"},{"name":"magnitude","data_type":"Union{Nothing, Float64}","null_value":"0.0","validation_action":"warn","comment":"voltage as a multiple of basevoltage","valid_range":"voltage_limits"},{"name":"voltage_limits","data_type":"Union{Nothing, MinMax}","null_value":"(min=0.0, max=0.0)","comment":"limits on the voltage variation as multiples of basevoltage"},{"name":"base_voltage","data_type":"Union{Nothing, Float64}","null_value":"nothing","validation_action":"error","comment":"the base voltage in kV","valid_range":{"max":null,"min":0}},{"name":"area","default":"nothing","data_type":"Union{Nothing, Area}","null_value":"nothing","comment":"the area containing the DC bus"},{"name":"load_zone","default":"nothing","data_type":"Union{Nothing, LoadZone}","null_value":"nothing","comment":"the load zone containing the DC bus"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"A power-system DC bus.","struct_name":"DCBus","supertype":"Bus"},{"fields":[{"name":"from","data_type":"Bus","null_value":"ACBus(nothing)","comment":"The initial bus"},{"name":"to","data_type":"Bus","null_value":"ACBus(nothing)","comment":"The terminal bus"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"A topological Arc.","struct_name":"Arc","supertype":"Topology","custom_code":"get_name(arc::Arc) = (get_name ∘ get_from)(arc) * \" -> \" * (get_name ∘ get_to)(arc)"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"active_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"arc","data_type":"Arc","null_value":"Arc(ACBus(nothing), ACBus(nothing))"},{"name":"r","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":4,"min":0}},{"name":"x","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":4,"min":0}},{"name":"b","data_type":"FromTo","null_value":"(from=0.0, to=0.0)","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":100,"min":0}},{"name":"rate","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"angle_limits","data_type":"MinMax","null_value":"(min=-1.571, max=1.571)","validation_action":"error","valid_range":{"max":1.571,"min":-1.571}},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"Line","supertype":"ACBranch"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"active_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"arc","data_type":"Arc","null_value":"Arc(ACBus(nothing), ACBus(nothing))"},{"name":"r","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":4,"min":0}},{"name":"x","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":4,"min":0}},{"name":"b","data_type":"FromTo","null_value":"(from=0.0, to=0.0)","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":2,"min":0}},{"name":"flow_limits","needs_conversion":true,"data_type":"FromTo_ToFrom","null_value":"(from_to=0.0, to_from=0.0)","comment":"throw warning above max SIL"},{"name":"rate","needs_conversion":true,"data_type":"Float64","null_value":"0.0","comment":"compare to SIL (warn) (theoretical limit)"},{"name":"angle_limits","data_type":"MinMax","null_value":"(min=-1.571, max=1.571)","validation_action":"error","valid_range":{"max":1.571,"min":-1.571}},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"MonitoredLine","supertype":"ACBranch"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"active_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"arc","data_type":"Arc","null_value":"Arc(ACBus(nothing), ACBus(nothing))"},{"name":"r","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":4,"min":0}},{"name":"x","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":4,"min":-2}},{"name":"primary_shunt","Comment":"System per-unit value","data_type":"Float64","null_value":"0.0","validation_action":"warn","valid_range":{"max":2,"min":0}},{"name":"tap","data_type":"Float64","null_value":"1.0","validation_action":"error","valid_range":{"max":2,"min":0}},{"name":"α","data_type":"Float64","null_value":"0.0","validation_action":"warn","valid_range":{"max":1.571,"min":-1.571}},{"name":"rate","needs_conversion":true,"data_type":"Union{Nothing, Float64}","null_value":"0.0","validation_action":"error","valid_range":{"max":null,"min":0}},{"name":"phase_angle_limits","default":"(min=-1.571, max=1.571)","data_type":"MinMax","null_value":"(min=-1.571, max=1.571)","validation_action":"error","valid_range":{"max":1.571,"min":-1.571}},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"PhaseShiftingTransformer","supertype":"ACBranch"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"active_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"arc","data_type":"Arc","null_value":"Arc(ACBus(nothing), ACBus(nothing))"},{"name":"r","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":2,"min":-2}},{"name":"x","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":4,"min":-2}},{"name":"primary_shunt","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":2,"min":0}},{"name":"tap","data_type":"Float64","null_value":"1.0","validation_action":"error","valid_range":{"max":2,"min":0}},{"name":"rate","needs_conversion":true,"data_type":"Union{Nothing, Float64}","null_value":"0.0","validation_action":"error","valid_range":{"max":null,"min":0}},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"TapTransformer","supertype":"ACBranch"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"active_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"arc","data_type":"Arc","null_value":"Arc(ACBus(nothing), ACBus(nothing))"},{"name":"r","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":4,"min":-2}},{"name":"x","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":4,"min":-2}},{"name":"primary_shunt","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"System per-unit value","valid_range":{"max":2,"min":0}},{"name":"rate","needs_conversion":true,"data_type":"Union{Nothing, Float64}","null_value":"nothing","validation_action":"error","valid_range":{"max":null,"min":0}},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"The 2-W transformer model uses an equivalent circuit assuming the impedance is on the High Voltage Side of the transformer. The model allocates the iron losses and magnetizing susceptance to the primary side.","struct_name":"Transformer2W","supertype":"ACBranch"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"active_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"arc","data_type":"Arc","null_value":"Arc(ACBus(nothing), ACBus(nothing))"},{"name":"active_power_limits_from","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"active_power_limits_to","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"reactive_power_limits_from","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"reactive_power_limits_to","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"loss","data_type":"NamedTuple{(:l0, :l1), Tuple{Float64, Float64}}","null_value":"(l0=0.0, l1=0.0)"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"a High voltage DC line.","struct_name":"TwoTerminalHVDCLine","supertype":"ACBranch"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"active_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"arc","data_type":"Arc","null_value":"Arc(ACBus(nothing), ACBus(nothing))"},{"name":"rectifier_tap_limits","data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"rectifier_xrc","data_type":"Float64","null_value":"0.0"},{"name":"rectifier_firing_angle","data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"inverter_tap_limits","data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"inverter_xrc","data_type":"Float64","null_value":"0.0"},{"name":"inverter_firing_angle","data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"As implemented in Milano's Book, Page 397.","struct_name":"TwoTerminalVSCDCLine","supertype":"ACBranch"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"active_power_flow","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"arc","data_type":"Arc","null_value":"Arc(DCBus(nothing), DCBus(nothing))"},{"name":"r","data_type":"Float64","null_value":"0.0","comment":"Series Resistance system per-unit value"},{"name":"l","data_type":"Float64","null_value":"0.0","comment":"Series Inductance system per-unit value"},{"name":"c","data_type":"Float64","null_value":"0.0","comment":"Shunt capacitance system per-unit value"},{"name":"active_power_limits_from","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"active_power_limits_to","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"a HVDC T-Model DC line.","struct_name":"TModelHVDCLine","supertype":"DCBranch"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"max_active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"max_reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"operation_cost","data_type":"TwoPartCost","null_value":"TwoPartCost(nothing)","comment":"Operation Cost of Generation [`TwoPartCost`](@ref)"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"InterruptiblePowerLoad","supertype":"ControllableLoad"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"Y","data_type":"Complex{Float64}","null_value":"0.0","comment":"System per-unit value"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection model for admittance"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"FixedAdmittance","supertype":"ElectricLoad"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"Y","data_type":"Complex{Float64}","null_value":"0.0","comment":"Initial impedance at N = 0"},{"name":"number_of_steps","default":"0","data_type":"Int","null_value":"0","comment":"Number of steps for adjustable shunt"},{"name":"Y_increase","default":"0","data_type":"Complex{Float64}","null_value":"0","comment":"Admittance increment for each of step increase"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection model for admittance"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"SwitchedAdmittance","supertype":"ElectricLoad"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"max_active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"max_reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data structure for a static power load.","struct_name":"PowerLoad","supertype":"StaticLoad"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"constant_active_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"constant_reactive_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"impedance_active_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"impedance_reactive_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"current_active_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"current_reactive_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"max_constant_active_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"max_constant_reactive_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"max_impedance_active_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"max_impedance_reactive_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"max_current_active_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"max_current_reactive_power","needs_conversion":true,"default":"0.0","data_type":"Float64","null_value":"0.0"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data structure for a standard load.","struct_name":"StandardLoad","supertype":"StaticLoad"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"active_power_coefficient","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Coefficient relating voltage dependence for power P = P0 * V^α","valid_range":{"max":null,"min":0}},{"name":"reactive_power_coefficient","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Coefficient relating voltage dependence for power Q = Q0 * V^β","valid_range":{"max":null,"min":0}},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"max_active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"max_reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data structure for a static exponential load.","struct_name":"ExponentialLoad","supertype":"StaticLoad"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"R_s","data_type":"Float64","null_value":0,"comment":"Armature stator resistance","valid_range":{"max":null,"min":0}},{"name":"R_r","data_type":"Float64","null_value":0,"comment":"Rotor resistance","valid_range":{"max":null,"min":0}},{"name":"X_ls","data_type":"Float64","null_value":0,"comment":"Stator Leakage Reactance","valid_range":{"max":null,"min":0}},{"name":"X_lr","data_type":"Float64","null_value":0,"comment":"Rotor Leakage Reactance","valid_range":{"max":null,"min":0}},{"name":"X_m","data_type":"Float64","null_value":0,"comment":"Stator-Rotor Mutual Reactance","valid_range":{"max":null,"min":0}},{"name":"H","data_type":"Float64","null_value":0,"comment":"Motor Inertia Constant [s]","valid_range":{"max":null,"min":0}},{"name":"A","data_type":"Float64","null_value":"0.0","comment":"Torque-Speed Quadratic Term","valid_range":{"max":1,"min":0}},{"name":"B","data_type":"Float64","null_value":"0.0","comment":"Torque-Speed Linear Term","valid_range":{"max":1,"min":0}},{"name":"base_power","data_type":"Float64","null_value":0,"comment":"Base power","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"C","data_type":"Float64","comment":"Torque-Speed Constant Term","internal_default":"PowerSystems.calculate_IM_torque_params(A, B)"},{"name":"τ_ref","data_type":"Float64","comment":"Reference torque parameter","internal_default":"1.0"},{"name":"B_shunt","data_type":"Float64","comment":"Susceptance Initialization Corrector Term","internal_default":"0.0"},{"name":"X_ad","data_type":"Float64","comment":"Equivalent d-axis reactance","internal_default":"(1.0 / X_m + 1.0 / X_ls + 1.0 / X_lr)^(-1)"},{"name":"X_aq","data_type":"Float64","comment":"Equivalent q-axis reactance","internal_default":"X_ad"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tψ_qs: stator flux in the q-axis,\n\tψ_ds: stator flux in the d-axis,\n\tψ_qr: rotor flux in the q-axis,\n\tψ_dr: rotor flux in the d-axis, \n\tωr: Rotor speed [pu],","internal_default":"[:ψ_qs, :ψ_ds, :ψ_qr, :ψ_dr, :ωr]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"SingleCageInductionMachine has 5 states","internal_default":5},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 5-states three-phase single cage induction machine with quadratic torque-speed relationship.","struct_name":"SingleCageInductionMachine","supertype":"DynamicInjection"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"R_s","data_type":"Float64","null_value":0,"comment":"Armature stator resistance","valid_range":{"max":null,"min":0}},{"name":"R_r","data_type":"Float64","null_value":0,"comment":"Rotor resistance","valid_range":{"max":null,"min":0}},{"name":"X_ls","data_type":"Float64","null_value":0,"comment":"Stator Leakage Reactance","valid_range":{"max":null,"min":0}},{"name":"X_lr","data_type":"Float64","null_value":0,"comment":"Rotor Leakage Reactance","valid_range":{"max":null,"min":0}},{"name":"X_m","data_type":"Float64","null_value":0,"comment":"Stator-Rotor Mutual Reactance","valid_range":{"max":null,"min":0}},{"name":"H","data_type":"Float64","null_value":0,"comment":"Motor Inertia Constant [s]","valid_range":{"max":null,"min":0}},{"name":"A","data_type":"Float64","null_value":"0.0","comment":"Torque-Speed Quadratic Term","valid_range":{"max":1,"min":0}},{"name":"B","data_type":"Float64","null_value":"0.0","comment":"Torque-Speed Linear Term","valid_range":{"max":1,"min":0}},{"name":"base_power","data_type":"Float64","null_value":0,"comment":"Base power","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"C","data_type":"Float64","comment":"Torque-Speed Constant Term","internal_default":"PowerSystems.calculate_IM_torque_params(A, B)"},{"name":"τ_ref","data_type":"Float64","comment":"Reference torque parameter","internal_default":"1.0"},{"name":"B_shunt","data_type":"Float64","comment":"Susceptance Initialization Corrector Term","internal_default":"0.0"},{"name":"X_ss","data_type":"Float64","comment":"Stator self reactance","internal_default":"X_ls + X_m"},{"name":"X_rr","data_type":"Float64","comment":"Rotor self reactance","internal_default":"X_lr + X_m"},{"name":"X_p","data_type":"Float64","comment":"Transient reactance","internal_default":"X_ss - X_m^2 / X_rr"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tψ_qr: rotor flux in the q-axis,\n\tψ_dr: rotor flux in the d-axis, \n\tωr: Rotor speed [pu],","internal_default":"[:ψ_qr, :ψ_dr, :ωr]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"SimplifiedSingleCageInductionMachine has 3 states","internal_default":3},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 3-states three-phase single cage induction machine with quadratic torque-speed relationship.","struct_name":"SimplifiedSingleCageInductionMachine","supertype":"DynamicInjection"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"a","data_type":"Float64","null_value":0,"comment":"Active power static exponential coefficient","valid_range":{"max":null,"min":0}},{"name":"b","data_type":"Float64","null_value":0,"comment":"Reactive power static exponential coefficient","valid_range":{"max":null,"min":0}},{"name":"α","data_type":"Float64","null_value":0,"comment":"Active power transient exponential coefficient","valid_range":{"max":null,"min":0}},{"name":"β","data_type":"Float64","null_value":0,"comment":"Reactive power transient exponential coefficient","valid_range":{"max":null,"min":0}},{"name":"T_p","data_type":"Float64","null_value":0,"comment":"Active Power Time Constant","valid_range":{"max":null,"min":0}},{"name":"T_q","data_type":"Float64","null_value":0,"comment":"Reactive Power Time Constant","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"base_power","data_type":"Float64","comment":"Base Power","internal_default":"100.0"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tx_p: Integrator state of the active power,\n\tx_q: Integrator state of the reactive power,","internal_default":"[:x_p, :x_q]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"DynamicExponentialLoad has 2 states","internal_default":2},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 2-states of a generic dynamic load model based on VOLTAGE STABILITY ANALYSIS USING GENERIC DYNAMIC LOAD MODELS by W. Xu and Y. Mansour, IEEE Transactions on Power Systems, 1994.","struct_name":"DynamicExponentialLoad","supertype":"DynamicInjection"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"r_load","data_type":"Float64","null_value":0,"comment":"DC-side resistor","valid_range":{"max":null,"min":0}},{"name":"c_dc","data_type":"Float64","null_value":0,"comment":"DC-side capacitor","valid_range":{"max":null,"min":0}},{"name":"rf","data_type":"Float64","null_value":0,"comment":"Converter side filter resistance","valid_range":{"max":null,"min":0}},{"name":"lf","data_type":"Float64","null_value":0,"comment":"Converter side filter inductance","valid_range":{"max":null,"min":0}},{"name":"cf","data_type":"Float64","null_value":0,"comment":"AC Converter filter capacitance","valid_range":{"max":null,"min":0}},{"name":"rg","data_type":"Float64","null_value":0,"comment":"Network side filter resistance","valid_range":{"max":null,"min":0}},{"name":"lg","data_type":"Float64","null_value":0,"comment":"Network side filter inductance","valid_range":{"max":null,"min":0}},{"name":"kp_pll","data_type":"Float64","null_value":0,"comment":"Proportional constant for PI-PLL block","valid_range":{"max":null,"min":0}},{"name":"ki_pll","data_type":"Float64","null_value":0,"comment":"Integral constant for PI-PLL block","valid_range":{"max":null,"min":0}},{"name":"kpv","data_type":"Float64","null_value":0,"comment":"Proportional constant for Voltage Control block","valid_range":{"max":null,"min":0}},{"name":"kiv","data_type":"Float64","null_value":0,"comment":"Integral constant for Voltage Control block","valid_range":{"max":null,"min":0}},{"name":"kpc","data_type":"Float64","null_value":0,"comment":"Proportional constant for Current Control block","valid_range":{"max":null,"min":0}},{"name":"kic","data_type":"Float64","null_value":0,"comment":"Integral constant for Current Control block","valid_range":{"max":null,"min":0}},{"name":"base_power","data_type":"Float64","null_value":0,"comment":"Base power","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"P_ref","data_type":"Float64","comment":"Reference active power parameter","internal_default":"1.0"},{"name":"Q_ref","data_type":"Float64","comment":"Reference reactive power parameter","internal_default":"1.0"},{"name":"V_ref","data_type":"Float64","comment":"Reference voltage parameter","internal_default":"1.0"},{"name":"ω_ref","data_type":"Float64","comment":"Reference frequency parameter","internal_default":"1.0"},{"name":"is_filter_differential","data_type":"Int","comment":"Boolean to decide if filter states are differential or algebraic","internal_default":"1"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tθ_pll: PLL deviation angle, \n\tϵ_pll: PLL integrator state, \n\tη: DC-voltage controller integrator state, \n\tv_dc: DC voltage at the capacitor, \n\tγd: d-axis Current controller integrator state, \n\tγq: q-axis Current controller integrator state, \n\tir_cnv: Real current out of the converter,\n\tii_cnv: Imaginary current out of the converter,\n\tvr_filter: Real voltage at the filter's capacitor,\n\tvi_filter: Imaginary voltage at the filter's capacitor,\n\tir_filter: Real current out of the filter,\n\tii_filter: Imaginary current out of the filter","internal_default":"[:θ_pll, :ϵ_pll, :η, :v_dc, :γd, :γq, :ir_cnv, :ii_cnv, :vr_filter, :vi_filter, :ir_filter, :ii_filter]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ActiveConstantPowerLoad has 12 states","internal_default":12},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 12-states active power load based on the paper Dynamic Stability of a Microgrid With an Active Load from N. Bottrell, M. Prodanovic and T. Green in IEEE Transactions on Power Electronics, 2013.","struct_name":"ActiveConstantPowerLoad","supertype":"DynamicInjection"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"dc_bus","data_type":"DCBus","null_value":"DCBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Active Power on the DCSide","valid_range":"active_power_limits"},{"name":"rating","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Thermal limited MVA Power Output of the converter. <= Capacity","valid_range":{"max":null,"min":0}},{"name":"active_power_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the converter in MVA","valid_range":{"max":null,"min":0}},{"name":"operation_cost","default":"TwoPartCost(0.0, 0.0)","data_type":"OperationalCost","null_value":"TwoPartCost(nothing)","comment":"Operation Cost of Generation [`OperationalCost`](@ref)"},{"name":"efficiency","default":"1.0","data_type":"Float64","null_value":"0.0","comment":"Conversion efficiency from AC Power to DC Power"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Interconnecting Power Converter (IPC) for transforming power from an ACBus to a DCBus","struct_name":"InterconnectingConverter","supertype":"StaticInjection"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"K","data_type":"Float64","null_value":0,"comment":"Gain in pu","valid_range":{"max":null,"min":0}},{"name":"T1","data_type":"Float64","null_value":0,"comment":"Time constant in s","valid_range":{"max":null,"min":0}},{"name":"T2","data_type":"Float64","null_value":0,"comment":"Time constant in s","valid_range":{"max":null,"min":0}},{"name":"T3","data_type":"Float64","null_value":0,"comment":"Time constant in s","valid_range":{"max":null,"min":"eps()"}},{"name":"T4","data_type":"Float64","null_value":0,"comment":"Time constant in s","valid_range":{"max":null,"min":0}},{"name":"T5","data_type":"Float64","null_value":0,"comment":"Time constant in s","valid_range":{"max":null,"min":0}},{"name":"Rmin","data_type":"Float64","null_value":0,"comment":"Reactor minimum Mvar","valid_range":{"max":null,"min":0}},{"name":"Vmax","data_type":"Float64","null_value":0,"comment":"Maximum voltage in pu","valid_range":{"max":null,"min":0}},{"name":"Vmin","data_type":"Float64","null_value":0,"comment":"Minimum voltage in pu","valid_range":{"max":null,"min":0}},{"name":"CBase","data_type":"Float64","null_value":0,"comment":"Capacitor Mvar","valid_range":{"max":null,"min":0}},{"name":"base_power","data_type":"Float64","null_value":0,"comment":"Base power","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"R_th","data_type":"Float64","comment":"Source Thevenin resistance","internal_default":"0.0"},{"name":"X_th","data_type":"Float64","comment":"Source Thevenin reactance","internal_default":"0.0"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tthy: thyristor,\n\tvr1: regulator output 1,\n\tvr2: regulator output 2","internal_default":"[:thy, :vr1, :vr2]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"CSVGN1 has 3 states","internal_default":3},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of static shunt compensator: CSVGN1 in PSSE","struct_name":"CSVGN1","supertype":"DynamicInjection"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"warn","valid_range":"reactive_power_limits"},{"name":"rating","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Thermal limited MVA Power Output of the unit. <= Capacity","valid_range":{"max":null,"min":0}},{"name":"prime_mover_type","data_type":"PrimeMovers","null_value":"PrimeMovers.HY","comment":"Prime mover technology according to EIA 923"},{"name":"active_power_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"reactive_power_limits","needs_conversion":true,"data_type":"Union{Nothing, MinMax}","null_value":"nothing","validation_action":"warn"},{"name":"ramp_limits","needs_conversion":true,"data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"ramp up and ramp down limits in MW (in component base per unit) per minute","valid_range":{"max":null,"min":0}},{"name":"time_limits","data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"Minimum up and Minimum down time limits in hours","valid_range":{"max":null,"min":0}},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"storage_capacity","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Maximum storage capacity in the reservoir (units can be p.u-hr or m^3).","valid_range":{"max":null,"min":0}},{"name":"inflow","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Baseline inflow into the reservoir (units can be p.u. or m^3/hr)","valid_range":{"max":null,"min":0}},{"name":"initial_storage","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Initial storage capacity in the reservoir (units can be p.u-hr or m^3).","valid_range":{"max":null,"min":0}},{"name":"operation_cost","default":"TwoPartCost(0.0, 0.0)","data_type":"OperationalCost","null_value":"TwoPartCost(nothing)","comment":"Operation Cost of Generation [`OperationalCost`](@ref)"},{"name":"storage_target","default":"1.0","data_type":"Float64","null_value":"0.0","comment":"Storage target at the end of simulation as ratio of storage capacity."},{"name":"conversion_factor","default":"1.0","data_type":"Float64","null_value":"0.0","comment":"Conversion factor from flow/volume to energy: m^3 -> p.u-hr."},{"name":"time_at_status","default":"INFINITE_TIME","data_type":"Float64","null_value":"INFINITE_TIME"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"HydroEnergyReservoir","supertype":"HydroGen"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"warn","valid_range":"reactive_power_limits"},{"name":"rating","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Thermal limited MVA Power Output of the unit. <= Capacity","valid_range":{"max":null,"min":0}},{"name":"prime_mover_type","data_type":"PrimeMovers","null_value":"PrimeMovers.HY","comment":"Prime mover technology according to EIA 923"},{"name":"active_power_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)","validation_action":"warn","valid_range":{"max":null,"min":0}},{"name":"reactive_power_limits","needs_conversion":true,"data_type":"Union{Nothing, MinMax}","null_value":"nothing","validation_action":"warn"},{"name":"ramp_limits","needs_conversion":true,"data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"ramp up and ramp down limits in MW (in component base per unit) per minute","valid_range":{"max":null,"min":0}},{"name":"time_limits","data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"Minimum up and Minimum down time limits in hours","valid_range":{"max":null,"min":0}},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"operation_cost","default":"TwoPartCost(0.0, 0.0)","data_type":"OperationalCost","null_value":"TwoPartCost(nothing)","comment":"Operation Cost of Generation [`OperationalCost`](@ref)"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"HydroDispatch","supertype":"HydroGen"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"rating","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Thermal limited MVA Power Output of the unit. <= Capacity","valid_range":{"max":null,"min":0}},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"prime_mover_type","data_type":"PrimeMovers","null_value":"PrimeMovers.HY","comment":"Prime mover technology according to EIA 923"},{"name":"active_power_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)","validation_action":"warn","valid_range":{"max":null,"min":0}},{"name":"reactive_power_limits","needs_conversion":true,"data_type":"Union{Nothing, MinMax}","null_value":"nothing","validation_action":"warn"},{"name":"ramp_limits","needs_conversion":true,"data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"ramp up and ramp down limits in MW (in component base per unit) per minute","valid_range":{"max":null,"min":0}},{"name":"time_limits","data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"Minimum up and Minimum down time limits in hours","valid_range":{"max":null,"min":0}},{"name":"rating_pump","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Thermal limited MVA Power Withdrawl of the pump. <= Capacity","valid_range":{"max":null,"min":0}},{"name":"active_power_limits_pump","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"reactive_power_limits_pump","needs_conversion":true,"data_type":"Union{Nothing, MinMax}","null_value":"nothing","validation_action":"warn"},{"name":"ramp_limits_pump","needs_conversion":true,"data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"ramp up and ramp down limits in MW (in component base per unit) per minute of pump","valid_range":{"max":null,"min":0}},{"name":"time_limits_pump","data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"Minimum up and Minimum down time limits of pump in hours","valid_range":{"max":null,"min":0}},{"name":"storage_capacity","needs_conversion":true,"data_type":"UpDown","null_value":"(up=0.0, down=0.0)","validation_action":"error","comment":"Maximum storage capacity in the upper and lower reservoirs (units can be p.u-hr or m^3).","valid_range":{"max":null,"min":0}},{"name":"inflow","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Baseline inflow into the upper reservoir (units can be p.u. or m^3/hr)","valid_range":{"max":null,"min":0}},{"name":"outflow","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Baseline outflow from the lower reservoir (units can be p.u. or m^3/hr)","valid_range":{"max":null,"min":0}},{"name":"initial_storage","needs_conversion":true,"data_type":"UpDown","null_value":"(up=0.0, down=0.0)","validation_action":"error","comment":"Initial storage capacity in the upper and lower reservoir (units can be p.u-hr or m^3).","valid_range":{"max":null,"min":0}},{"name":"storage_target","default":"(up=1.0, down=1.0)","data_type":"UpDown","null_value":"(up=0.0, down=0.0)","comment":"Storage target of upper reservoir at the end of simulation as ratio of storage capacity."},{"name":"operation_cost","default":"TwoPartCost(0.0, 0.0)","data_type":"OperationalCost","null_value":"TwoPartCost(nothing)","comment":"Operation Cost of Generation [`OperationalCost`](@ref)"},{"name":"pump_efficiency","default":"1.0","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Efficiency of pump","valid_range":{"max":1,"min":0}},{"name":"conversion_factor","default":"1.0","data_type":"Float64","null_value":"0.0","comment":"Conversion factor from flow/volume to energy: m^3 -> p.u-hr."},{"name":"time_at_status","default":"INFINITE_TIME","data_type":"Float64","null_value":"INFINITE_TIME"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"HydroPumpedStorage","supertype":"HydroGen"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"rating","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Thermal limited MVA Power Output of the unit. <= Capacity","valid_range":{"max":null,"min":0}},{"name":"prime_mover_type","data_type":"PrimeMovers","null_value":"PrimeMovers.OT","comment":"Prime mover technology according to EIA 923"},{"name":"reactive_power_limits","needs_conversion":true,"data_type":"Union{Nothing, MinMax}","null_value":"nothing"},{"name":"power_factor","data_type":"Float64","null_value":"1.0","validation_action":"error","valid_range":{"max":1,"min":0}},{"name":"operation_cost","data_type":"TwoPartCost","null_value":"TwoPartCost(nothing)","comment":"Operation Cost of Generation [`TwoPartCost`](@ref)"},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"RenewableDispatch","supertype":"RenewableGen"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"rating","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Thermal limited MVA Power Output of the unit. <= Capacity","valid_range":{"max":null,"min":0}},{"name":"prime_mover_type","data_type":"PrimeMovers","null_value":"PrimeMovers.OT","comment":"Prime mover technology according to EIA 923"},{"name":"power_factor","data_type":"Float64","null_value":"1.0","validation_action":"error","valid_range":{"max":1,"min":0}},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data Structure for fixed renewable generation technologies.","struct_name":"RenewableFix","supertype":"RenewableGen"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"status","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"warn","valid_range":"active_power_limits"},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"warn","valid_range":"reactive_power_limits"},{"name":"rating","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Thermal limited MVA Power Output of the unit. <= Capacity","valid_range":{"max":null,"min":0}},{"name":"active_power_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)","validation_action":"warn","valid_range":{"max":null,"min":0}},{"name":"reactive_power_limits","needs_conversion":true,"data_type":"Union{Nothing, MinMax}","null_value":"nothing"},{"name":"ramp_limits","needs_conversion":true,"data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"ramp up and ramp down limits in MW (in component base per unit) per minute","valid_range":{"max":null,"min":0}},{"name":"operation_cost","data_type":"OperationalCost","null_value":"ThreePartCost(nothing)"},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"time_limits","default":"nothing","data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"Minimum up and Minimum down time limits in hours","valid_range":{"max":null,"min":0}},{"name":"must_run","default":"false","data_type":"Bool","null_value":"false"},{"name":"prime_mover_type","default":"PrimeMovers.OT","data_type":"PrimeMovers","null_value":"PrimeMovers.OT","comment":"Prime mover technology according to EIA 923"},{"name":"fuel","default":"ThermalFuels.OTHER","data_type":"ThermalFuels","null_value":"ThermalFuels.OTHER","comment":"Prime mover fuel according to EIA 923"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"time_at_status","default":"INFINITE_TIME","data_type":"Float64","null_value":"INFINITE_TIME"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data Structure for thermal generation technologies.","struct_name":"ThermalStandard","supertype":"ThermalGen"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"status","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"warn","valid_range":"active_power_limits"},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"warn","valid_range":"reactive_power_limits"},{"name":"rating","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Thermal limited MVA Power Output of the unit. <= Capacity","valid_range":{"max":null,"min":0}},{"name":"prime_mover_type","data_type":"PrimeMovers","null_value":"PrimeMovers.OT","comment":"Prime mover technology according to EIA 923"},{"name":"fuel","data_type":"ThermalFuels","null_value":"ThermalFuels.OTHER","comment":"Prime mover fuel according to EIA 923"},{"name":"active_power_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)"},{"name":"reactive_power_limits","needs_conversion":true,"data_type":"Union{Nothing, MinMax}","null_value":"nothing"},{"name":"ramp_limits","needs_conversion":true,"data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","valid_range":{"max":null,"min":0}},{"name":"power_trajectory","needs_conversion":true,"data_type":"Union{Nothing, StartUpShutDown}","null_value":"nothing","validation_action":"error","comment":"Power trajectory the unit will take during the start-up and shut-down ramp process","valid_range":{"max":null,"min":0}},{"name":"time_limits","data_type":"Union{Nothing, UpDown}","null_value":"nothing","validation_action":"error","comment":"Minimum up and Minimum down time limits in hours","valid_range":{"max":null,"min":0}},{"name":"start_time_limits","data_type":"Union{Nothing, NamedTuple{(:hot, :warm, :cold), Tuple{Float64, Float64, Float64}}}","null_value":"nothing","comment":" Time limits for start-up based on turbine temperature in hours"},{"name":"start_types","data_type":"Int","null_value":"1","validation_action":"error","comment":" Number of start-up based on turbine temperature","valid_range":{"max":3,"min":1}},{"name":"operation_cost","data_type":"OperationalCost","null_value":"MultiStartCost(nothing)"},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"time_at_status","default":"INFINITE_TIME","data_type":"Float64","null_value":"INFINITE_TIME"},{"name":"must_run","default":"false","data_type":"Bool","null_value":"false"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data Structure for thermal generation technologies.","struct_name":"ThermalMultiStart","supertype":"ThermalGen"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"prime_mover_type","data_type":"PrimeMovers","null_value":"PrimeMovers.BA","comment":"Prime mover technology according to EIA 923"},{"name":"initial_energy","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"State of Charge of the Battery p.u.-hr","valid_range":{"max":null,"min":0}},{"name":"state_of_charge_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)","validation_action":"error","comment":"Maximum and Minimum storage capacity in p.u.-hr","valid_range":{"max":null,"min":0}},{"name":"rating","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"input_active_power_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)","validation_action":"error","valid_range":{"max":null,"min":0}},{"name":"output_active_power_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)","validation_action":"error","valid_range":{"max":null,"min":0}},{"name":"efficiency","data_type":"NamedTuple{(:in, :out), Tuple{Float64, Float64}}","null_value":"(in=0.0, out=0.0)","validation_action":"warn","valid_range":{"max":1,"min":0}},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"warn","valid_range":"reactive_power_limits"},{"name":"reactive_power_limits","needs_conversion":true,"data_type":"Union{Nothing, MinMax}","null_value":"(min=0.0, max=0.0)"},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"operation_cost","default":"StorageManagementCost()","data_type":"Union{StorageManagementCost, MarketBidCost}","null_value":"StorageManagementCost()"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data structure for a generic battery","struct_name":"GenericBattery","supertype":"Storage"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"prime_mover_type","data_type":"PrimeMovers","null_value":"PrimeMovers.BA","comment":"Prime mover technology according to EIA 923"},{"name":"initial_energy","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"State of Charge of the Battery p.u.-hr","valid_range":{"max":null,"min":0}},{"name":"state_of_charge_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)","validation_action":"error","comment":"Maximum and Minimum storage capacity in p.u.-hr","valid_range":{"max":null,"min":0}},{"name":"rating","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"active_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0"},{"name":"input_active_power_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)","validation_action":"error","valid_range":{"max":null,"min":0}},{"name":"output_active_power_limits","needs_conversion":true,"data_type":"MinMax","null_value":"(min=0.0, max=0.0)","validation_action":"error","valid_range":{"max":null,"min":0}},{"name":"efficiency","data_type":"NamedTuple{(:in, :out), Tuple{Float64, Float64}}","null_value":"(in=0.0, out=0.0)","validation_action":"warn","valid_range":{"max":1,"min":0}},{"name":"reactive_power","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"warn","valid_range":"reactive_power_limits"},{"name":"reactive_power_limits","needs_conversion":true,"data_type":"Union{Nothing, MinMax}","null_value":"(min=0.0, max=0.0)"},{"name":"base_power","data_type":"Float64","null_value":"0.0","validation_action":"warn","comment":"Base power of the unit in MVA","valid_range":{"max":null,"min":0}},{"name":"operation_cost","default":"Union{StorageManagementCost, MarketBidCost}","data_type":"StorageManagementCost","null_value":"StorageManagementCost()"},{"name":"storage_target","default":"0.0","data_type":"Float64","null_value":"0.0","comment":"Storage target at the end of simulation as ratio of storage capacity."},{"name":"cycle_limits","default":"1e4","data_type":"Int","null_value":"0","comment":"Storage Maximum number of cycles per year"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data structure for a battery compatible with energy management formulations.","struct_name":"BatteryEMS","supertype":"Storage"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"time_frame","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the saturation time_frame in minutes to provide reserve contribution","valid_range":{"max":null,"min":0}},{"name":"requirement","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the static value of required reserves in system p.u.","valid_range":{"max":null,"min":0}},{"name":"sustained_time","default":"3600.0","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the time in secounds reserve contribution must sustained at a specified level","valid_range":{"max":null,"min":0}},{"name":"max_output_fraction","default":"1.0","data_type":"Float64","null_value":"1.0","validation_action":"error","comment":"the maximum fraction of the device's output that can be assigned to the service","valid_range":{"max":1,"min":0}},{"name":"max_participation_factor","default":"1.0","data_type":"Float64","null_value":"1.0","validation_action":"error","comment":"the maximum limit of reserve contribution per device","valid_range":{"max":1,"min":0}},{"name":"deployed_fraction","default":"0.0","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Fraction of ancillary services participation deployed from the assignment","valid_range":{"max":1,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data Structure for a proportional reserve product for system simulations.","parametric":"ReserveDirection","struct_name":"StaticReserve","supertype":"Reserve{T}"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"time_frame","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the saturation time_frame in minutes to provide reserve contribution","valid_range":{"max":null,"min":0}},{"name":"requirement","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the static value of required reserves in system p.u.","valid_range":{"max":null,"min":0}},{"name":"sustained_time","default":"3600.0","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the time in secounds reserve contribution must sustained at a specified level","valid_range":{"max":null,"min":0}},{"name":"max_output_fraction","default":"1.0","data_type":"Float64","null_value":"1.0","validation_action":"error","comment":"the maximum fraction of the device's output that can be assigned to the service","valid_range":{"max":1,"min":0}},{"name":"max_participation_factor","default":"1.0","data_type":"Float64","null_value":"1.0","validation_action":"error","comment":"the maximum limit of reserve contribution per device","valid_range":{"max":1,"min":0}},{"name":"deployed_fraction","default":"0.0","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Fraction of ancillary services participation deployed from the assignment","valid_range":{"max":1,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data Structure for a non-spinning reserve product for system simulations.","struct_name":"StaticReserveNonSpinning","supertype":"ReserveNonSpinning"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"requirement","needs_conversion":true,"data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the static value of required reserves in system p.u.","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"contributing_services","default":"Vector{Service}()","data_type":"Vector{Service}","exclude_setter":true,"null_value":"Vector{Service}()","comment":"Services that contribute for this requirement constraint"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data Structure for a group reserve product for system simulations.","parametric":"ReserveDirection","struct_name":"StaticReserveGroup","supertype":"Service"},{"fields":[{"name":"variable","data_type":"Union{Nothing, IS.TimeSeriesKey}","null_value":"nothing","comment":"Variable Cost TimeSeriesKey"},{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"time_frame","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the saturation time_frame in minutes to provide reserve contribution","valid_range":{"max":null,"min":0}},{"name":"sustained_time","default":"3600.0","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the time in secounds reserve contribution must sustained at a specified level","valid_range":{"max":null,"min":0}},{"name":"max_participation_factor","default":"1.0","data_type":"Float64","null_value":"1.0","validation_action":"error","comment":"the maximum limit of reserve contribution per device","valid_range":{"max":1,"min":0}},{"name":"deployed_fraction","default":"0.0","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Fraction of ancillary services participation deployed from the assignment","valid_range":{"max":1,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data Structure for a operating reserve with demand curve product for system simulations.","parametric":"ReserveDirection","struct_name":"ReserveDemandCurve","supertype":"Reserve{T}"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"time_frame","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the saturation time_frame in minutes to provide reserve contribution","valid_range":{"max":null,"min":0}},{"name":"requirement","data_type":"Float64","null_value":"0.0","comment":"the required quantity of the product should be scaled by a TimeSeriesData"},{"name":"sustained_time","default":"3600.0","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the time in secounds reserve contribution must sustained at a specified level","valid_range":{"max":null,"min":0}},{"name":"max_output_fraction","default":"1.0","data_type":"Float64","null_value":"1.0","validation_action":"error","comment":"the maximum fraction of the device's output that can be assigned to the service","valid_range":{"max":1,"min":0}},{"name":"max_participation_factor","default":"1.0","data_type":"Float64","null_value":"1.0","validation_action":"error","comment":"the maximum limit of reserve contribution per device","valid_range":{"max":1,"min":0}},{"name":"deployed_fraction","default":"0.0","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Fraction of ancillary services participation deployed from the assignment","valid_range":{"max":1,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data Structure for the procurement products for system simulations.","parametric":"ReserveDirection","struct_name":"VariableReserve","supertype":"Reserve{T}"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"time_frame","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the saturation time_frame in minutes to provide reserve contribution","valid_range":{"max":null,"min":0}},{"name":"requirement","needs_conversion":true,"data_type":"Float64","null_value":"0.0","comment":"the required quantity of the product should be scaled by a TimeSeriesData"},{"name":"sustained_time","default":"14400.0","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"the time in secounds reserve contribution must sustained at a specified level","valid_range":{"max":null,"min":0}},{"name":"max_output_fraction","default":"1.0","data_type":"Float64","null_value":"1.0","validation_action":"error","comment":"the maximum fraction of the device's output that can be assigned to the service","valid_range":{"max":1,"min":0}},{"name":"max_participation_factor","default":"1.0","data_type":"Float64","null_value":"1.0","validation_action":"error","comment":"the maximum limit of reserve contribution per device","valid_range":{"max":1,"min":0}},{"name":"deployed_fraction","default":"0.0","data_type":"Float64","null_value":"0.0","validation_action":"error","comment":"Fraction of ancillary services participation deployed from the assignment","valid_range":{"max":1,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Data Structure for the procurement products for system simulations.","struct_name":"VariableReserveNonSpinning","supertype":"ReserveNonSpinning"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bias","data_type":"Float64","null_value":"0.0"},{"name":"K_p","data_type":"Float64","null_value":"0.0","comment":"PID Proportional Constant"},{"name":"K_i","data_type":"Float64","null_value":"0.0","comment":"PID Integral Constant"},{"name":"K_d","data_type":"Float64","null_value":"0.0","comment":"PID Derrivative Constant"},{"name":"delta_t","data_type":"Float64","null_value":"0.0","comment":"PID Discretization period [Seconds]"},{"name":"area","default":"nothing","data_type":"Union{Nothing, Area}","null_value":"Area(nothing)","comment":"the area controlled by the AGC"},{"name":"initial_ace","default":"0.0","data_type":"Float64","null_value":"0.0","comment":"PID Discretization period [Seconds]"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"AGC","supertype":"Service"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"requirement","data_type":"Float64","null_value":"0.0"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"time_series_container","default":"InfrastructureSystems.TimeSeriesContainer()","data_type":"InfrastructureSystems.TimeSeriesContainer","null_value":"InfrastructureSystems.TimeSeriesContainer()","comment":"internal time_series storage"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"struct_name":"Transfer","supertype":"Service"},{"fields":[{"name":"Vf","data_type":"Float64","null_value":0,"comment":"Fixed voltage field applied to the rotor winding","valid_range":{"max":null,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"Fixed AVR has no states","internal_default":"Vector{Symbol}()"},{"name":"n_states","data_type":"Int","exclude_setter":true,"null_value":0,"comment":"Fixed AVR has no states","internal_default":0},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"Fixed AVR has no states","internal_default":"Vector{StateTypes}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of a AVR that returns a fixed voltage to the rotor winding","struct_name":"AVRFixed","supertype":"AVR"},{"fields":[{"name":"Kv","data_type":"Float64","null_value":0,"comment":"Proportional Gain","valid_range":{"max":null,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVf: field voltage","internal_default":"[:Vf]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"Fixed AVR has 1 states","internal_default":1},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"Simple AVR has 1 differential states","internal_default":"[StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of a simple proportional AVR in the derivative of EMF\ni.e. an integrator controller on EMF","struct_name":"AVRSimple","supertype":"AVR"},{"fields":[{"name":"Ta_Tb","data_type":"Float64","null_value":0,"comment":"Ratio of lead and lag time constants","valid_range":{"max":null,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"comment":"Lag time constant","valid_range":{"max":null,"min":"eps()"}},{"name":"K","data_type":"Float64","null_value":0,"comment":"Gain","valid_range":{"max":null,"min":0}},{"name":"Te","data_type":"Float64","null_value":0,"comment":"Field circuit time constant in s","valid_range":{"max":null,"min":0}},{"name":"V_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Field voltage limits"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\tVf: Voltage field,\tVr: Lead-lag state","internal_default":"[:Vf, :Vr]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"SEXS has 2 states","internal_default":2},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"SEXS has 2 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of Simplified Excitation System Model - SEXS in PSSE","struct_name":"SEXS","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage Measurement Time Constant in s","valid_range":{"max":0.5,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Amplifier Gain","valid_range":{"max":500,"min":10}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Amplifier Time Constant in s","valid_range":{"max":1,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Tc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Voltage regulator limits (regulator output) (Vi_min, Vi_max)"},{"name":"Ke","data_type":"Float64","null_value":0,"comment":"Exciter constant related to self-excited field","valid_range":{"max":null,"min":0}},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Exciter time constant, integration rate associated with exciter control","valid_range":{"max":1,"min":"eps()"}},{"name":"Kf","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Excitation control system stabilizer gain","valid_range":{"max":0.3,"min":"eps()"}},{"name":"Tf","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Excitation control system stabilizer time constant","valid_range":{"max":null,"min":"eps()"}},{"name":"switch","data_type":"Int","null_value":0,"validation_action":"error","comment":"Switch","valid_range":{"max":1,"min":0}},{"name":"E_sat","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter output voltage for saturation factor: (E1, E2)"},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter saturation factor at exciter output voltage: (Se(E1), Se(E2))"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"saturation_coeffs","default":"PowerSystems.get_avr_saturation(E_sat, Se)","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Coefficients (A,B) of the function: Se(V) = B(V - A)^2/V"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVt: Terminal Voltage,\n\tVr1: input lead lag,\n\tVr2: Regulator Output,\n\tVf: Exciter Output, \n\tVr3: Rate feedback integrator","internal_default":"[:Vt, :Vr1, :Vr2, :Vf, :Vr3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The ESDC1A has 5 states","internal_default":5},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"ESDC1A has 5 differential states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Self-excited shunt fields with the voltage regulator operating in a mode commonly termed buck-boost. \nParameters of IEEE Std 421.5 Type DC1A Excitacion System. This model corresponds to ESDC1A in PSSE and PSLF","struct_name":"ESDC1A","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage Measurement Time Constant in s","valid_range":{"max":0.5,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Amplifier Gain","valid_range":{"max":500,"min":10}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Amplifier Time Constant in s","valid_range":{"max":1,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Tc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Voltage regulator limits (regulator output) (Vi_min, Vi_max)"},{"name":"Ke","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter constant related to self-excited field","valid_range":{"max":1,"min":-1}},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Exciter time constant, integration rate associated with exciter control","valid_range":{"max":2,"min":"eps()"}},{"name":"Kf","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Excitation control system stabilizer gain","valid_range":{"max":0.3,"min":0}},{"name":"Tf","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Excitation control system stabilizer time constant. Appropiate Data: 5.0 <= Tf/Kf <= 15.0","valid_range":{"max":1.5,"min":"eps()"}},{"name":"switch","data_type":"Int","null_value":0,"validation_action":"error","comment":"Switch","valid_range":{"max":1,"min":0}},{"name":"E_sat","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter output voltage for saturation factor: (E1, E2)"},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter saturation factor at exciter output voltage: (Se(E1), Se(E2))"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"saturation_coeffs","default":"PowerSystems.get_avr_saturation(E_sat, Se)","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Coefficients (A,B) of the function: Se(V) = B(V - A)^2/V"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVt: Terminal Voltage,\n\tVr1: input lead lag,\n\tVr2: Regulator Output,\n\tVf: Exciter Output, \n\tVr3: Rate feedback integrator","internal_default":"[:Vt, :Vr1, :Vr2, :Vf, :Vr3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The ESDC2A has 5 states","internal_default":5},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"ESDC2A has 5 differential states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Is used to represent field-controlled dc commutator exciters with continuously acting voltage regulators having power supplies derived from the generator or auxiliaries bus.\nParameters of IEEE Std 421.5 Type DC2A Excitacion System. This model corresponds to ESDC2A in PSSE and PSLF","struct_name":"ESDC2A","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage Measurement Time Constant in s","valid_range":{"max":0.5,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Amplifier Gain","valid_range":{"max":500,"min":10}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Amplifier Time Constant in s","valid_range":{"max":1,"min":0}},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Voltage regulator limits (regulator output) (Vi_min, Vi_max)"},{"name":"Ke","data_type":"Float64","null_value":0,"comment":"Exciter constant related to self-excited field","valid_range":{"max":1,"min":-1}},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Exciter time constant, integration rate associated with exciter control","valid_range":{"max":1,"min":"eps()"}},{"name":"Kf","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Excitation control system stabilizer gain","valid_range":{"max":0.3,"min":"eps()"}},{"name":"Tf","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Excitation control system stabilizer time constant. Appropiate Data: 5 <= Tf/Kf <= 15","valid_range":{"max":null,"min":"eps()"}},{"name":"switch","data_type":"Int","null_value":0,"validation_action":"error","comment":"Switch","valid_range":{"max":1,"min":0}},{"name":"E_sat","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter output voltage for saturation factor: (E1, E2)"},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter saturation factor at exciter output voltage: (Se(E1), Se(E2))"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"saturation_coeffs","default":"PowerSystems.get_avr_saturation(E_sat, Se)","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Coefficients (A,B) of the function: Se(V) = B(V - A)^2/V"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVt: Terminal Voltage,\n\tVr: Regulator Output,\n\tVf: Exciter Output, \n\tVr3: Rate feedback integrator","internal_default":"[:Vt, :Vr1, :Vf, :Vr2]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The IEEET1 has 4 states","internal_default":4},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"IEEET1 I has 4 differential states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"1968 IEEE type 1 excitation system model","struct_name":"IEEET1","supertype":"AVR"},{"fields":[{"name":"Ka","data_type":"Float64","null_value":0,"comment":"Amplifier Gain","valid_range":{"max":null,"min":0}},{"name":"Ke","data_type":"Float64","null_value":0,"comment":"Field circuit integral deviation","valid_range":{"max":null,"min":0}},{"name":"Kf","data_type":"Float64","null_value":0,"comment":"Stabilizer Gain in s * pu/pu","valid_range":{"max":null,"min":0}},{"name":"Ta","data_type":"Float64","null_value":0,"comment":"Amplifier Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Te","data_type":"Float64","null_value":0,"comment":"Field Circuit Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Tf","data_type":"Float64","null_value":0,"comment":"Stabilizer Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Tr","data_type":"Float64","null_value":0,"comment":"Voltage Measurement Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Va_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for pi controler `(Va_min, Va_max)`"},{"name":"Ae","data_type":"Float64","null_value":0,"comment":"1st ceiling coefficient","valid_range":{"max":null,"min":0}},{"name":"Be","data_type":"Float64","null_value":0,"comment":"2nd ceiling coefficient","valid_range":{"max":null,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVf: Voltage field,\n\tVr1: Amplifier State,\n\tVr2: Stabilizing Feedback State,\n\tVm: Measured voltage","internal_default":"[:Vf, :Vr1, :Vr2, :Vm]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The AVR Type I has 4 states","internal_default":4},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"AVR Type I has 4 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of an Automatic Voltage Regulator Type I - Resembles IEEE Type DC1","struct_name":"AVRTypeI","supertype":"AVR"},{"fields":[{"name":"K0","data_type":"Float64","null_value":0,"comment":"Regulator Gain","valid_range":{"max":null,"min":0}},{"name":"T1","data_type":"Float64","null_value":0,"comment":"First Pole in s","valid_range":{"max":null,"min":0}},{"name":"T2","data_type":"Float64","null_value":0,"comment":"First zero in s","valid_range":{"max":null,"min":0}},{"name":"T3","data_type":"Float64","null_value":0,"comment":"First Pole in s","valid_range":{"max":null,"min":0}},{"name":"T4","data_type":"Float64","null_value":0,"comment":"First zero in s","valid_range":{"max":null,"min":0}},{"name":"Te","data_type":"Float64","null_value":0,"comment":"Field Circuit Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Tr","data_type":"Float64","null_value":0,"comment":"Voltage Measurement Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Va_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for pi controler `(Va_min, Va_max)`"},{"name":"Ae","data_type":"Float64","null_value":0,"comment":"1st ceiling coefficient","valid_range":{"max":null,"min":0}},{"name":"Be","data_type":"Float64","null_value":0,"comment":"2nd ceiling coefficient","valid_range":{"max":null,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVf: Voltage field,\n\tVr1: First Lead-Lag state,\n\tVr2: Second lead-lag state,\n\tVm: Measured voltage","internal_default":"[:Vf, :Vr1, :Vr2, :Vm]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"AVR Type II has 4 states","internal_default":4},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"AVR Type II has 4 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of an Automatic Voltage Regulator Type II - Typical static exciter model","struct_name":"AVRTypeII","supertype":"AVR"},{"fields":[{"name":"Ta_Tb","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Lead input constant ratio","valid_range":{"max":0.3,"min":0.05}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Lag input constant in s","valid_range":{"max":20,"min":5}},{"name":"K","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator Gain","valid_range":{"max":100,"min":20}},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator Time Constant","valid_range":{"max":1,"min":0}},{"name":"Efd_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Field Voltage regulator limits (regulator output) (Efd_min, Efd_max)"},{"name":"switch","data_type":"Int","null_value":0,"validation_action":"error","comment":"Switch","valid_range":{"max":1,"min":0}},{"name":"rc_rfd","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Field current capability. Set = 0 for negative current capability. Typical value 10","valid_range":{"max":10,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVr1: First integrator,\n\tVr2: Second integrator","internal_default":"[:Vr1, :Vr2]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"SCRX has 2 states","internal_default":2},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"SCRX has 2 differential states","internal_default":"[StateTypes.Differential, StateTypes.Hybrid]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"This exciter is based on an IEEE type SCRX solid state exciter. The output field voltage is varied by a control system to maintain the system voltage at Vref. Please note that this exciter model has no initialization capabilities - this means that it will respond to whatever inputs it receives regardless of the state of the machine model.","struct_name":"SCRX","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input filter time constant in s","valid_range":{"max":0.5,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator denominator (lag) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Tc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator numerator (lead) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator output gain","valid_range":{"max":1000,"min":0}},{"name":"Ta","data_type":"Float64","null_value":0,"comment":"Regulator output time constant in s","valid_range":{"max":10,"min":0}},{"name":"Va_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for regulator output `(Va_min, Va_max)`"},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Exciter field time constant in s","valid_range":{"max":2,"min":"eps()"}},{"name":"Kf","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rate feedback excitation system stabilizer gain","valid_range":{"max":0.3,"min":0}},{"name":"Tf","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Rate feedback time constant","valid_range":{"max":1.5,"min":"eps()"}},{"name":"Kc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rectifier loading factor proportional to commutating reactance","valid_range":{"max":1,"min":0}},{"name":"Kd","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Demagnetizing factor, function of exciter alternator reactances","valid_range":{"max":1,"min":0}},{"name":"Ke","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter field proportional constant","valid_range":{"max":1,"min":0}},{"name":"E_sat","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter output voltage for saturation factor: (E1, E2)"},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter saturation factor at exciter output voltage: (Se(E1), Se(E2))"},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for exciter field voltage: `(Vr_min, Vr_max)`"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"saturation_coeffs","default":"PowerSystems.get_avr_saturation(E_sat, Se)","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Coefficients (A,B) of the function: Se(x) = B(x - A)^2/x"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVm: Sensed terminal voltage,\n\tVr1: Lead-lag state,\n\tVr2: Regulator output state,\n\tVe: Integrator output state,\n\tVr3: Feedback output state","internal_default":"[:Vm, :Vr1, :Vr2, :Ve, :Vr3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ESAC1A has 5 states","internal_default":5},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"ESAC1A has 5 states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"This excitation systems consists of an alternator main exciter feeding its output via non-controlled rectifiers.\nThe exciter does not employ self-excitation, and the voltage regulator power is taken from a source that is not affected by external transients.\nParameters of IEEE Std 421.5 Type AC1A Excitacion System. This model corresponds to ESAC1A in PSSE and PSLF","struct_name":"ESAC1A","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input filter time constant in s","valid_range":{"max":0.5,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator denominator (lag) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Tc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator numerator (lead) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator output gain","valid_range":{"max":1000,"min":0}},{"name":"Ta","data_type":"Float64","null_value":0,"comment":"Regulator output time constant in s","valid_range":{"max":10,"min":0}},{"name":"Va_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for regulator output `(Va_min, Va_max)`"},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Exciter field time constant in s","valid_range":{"max":2,"min":"eps()"}},{"name":"Kf","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rate feedback excitation system stabilizer gain","valid_range":{"max":0.3,"min":0}},{"name":"Tf","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Rate feedback time constant","valid_range":{"max":1.5,"min":"eps()"}},{"name":"Kc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rectifier loading factor proportional to commutating reactance","valid_range":{"max":1,"min":0}},{"name":"Kd","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Demagnetizing factor, function of exciter alternator reactances","valid_range":{"max":1,"min":0}},{"name":"Ke","data_type":"Float64","null_value":0,"comment":"Exciter field proportional constant","valid_range":{"max":1,"min":0}},{"name":"E_sat","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter output voltage for saturation factor: (E1, E2)"},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter saturation factor at exciter output voltage: (Se(E1), Se(E2))"},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for exciter field voltage: `(Vr_min, Vr_max)`"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"saturation_coeffs","default":"PowerSystems.get_avr_saturation(E_sat, Se)","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Coefficients (A,B) of the function: Se(x) = B(x - A)^2/x"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVm: Sensed terminal voltage,\n\tVr1: Lead-lag state,\n\tVr2: Regulator output state,\n\tVe: Integrator output state,\n\tVr3: Feedback output state","internal_default":"[:Vm, :Vr1, :Vr2, :Ve, :Vr3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"EXAC1A has 5 states","internal_default":5},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"EXAC1A has 5 states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Modified ESAC1A. This excitation systems consists of an alternator main exciter feeding its output via non-controlled rectifiers.\nThe exciter does not employ self-excitation, and the voltage regulator power is taken from a source that is not affected by external transients.\nParameters of IEEE Std 421.5 Type AC1A Excitacion System. EXAC1A in PSSE and PSLF","struct_name":"EXAC1A","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input filter time constant in s","valid_range":{"max":0.5,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator denominator (lag) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Tc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator numerator (lead) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"comment":"Regulator output gain","valid_range":{"max":1000,"min":0}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator output time constant in s","valid_range":{"max":10,"min":0}},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for regulator output `(Vr_min, Vr_max)`"},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Exciter field time constant in s","valid_range":{"max":2,"min":"eps()"}},{"name":"Kf","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rate feedback excitation system stabilizer gain","valid_range":{"max":0.3,"min":0}},{"name":"Tf","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Rate feedback time constant","valid_range":{"max":1.5,"min":"eps()"}},{"name":"Kc","data_type":"Float64","null_value":0,"comment":"Rectifier loading factor proportional to commutating reactance","valid_range":{"max":1,"min":0}},{"name":"Kd","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Demagnetizing factor, function of exciter alternator reactances","valid_range":{"max":1,"min":0}},{"name":"Ke","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter field proportional constant","valid_range":{"max":1,"min":0}},{"name":"E_sat","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter output voltage for saturation factor: (E1, E2)"},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter saturation factor at exciter output voltage: (Se(E1), Se(E2))"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"saturation_coeffs","default":"PowerSystems.get_avr_saturation(E_sat, Se)","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Coefficients (A,B) of the function: Se(V) = B(V - A)^2/V"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVm: Sensed terminal voltage,\n\tVr1: Lead-lag state,\n\tVr2: Regulator output state,\n\tVe: Integrator output state,\n\tVr3: Feedback output state","internal_default":"[:Vm, :Vr1, :Vr2, :Ve, :Vr3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"EXAC1 has 5 states","internal_default":5},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"EXAC1 has 5 states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Modified ESAC1A. This excitation systems consists of an alternator main exciter feeding its output via non-controlled rectifiers.\nThe exciter does not employ self-excitation, and the voltage regulator power is taken from a source that is not affected by external transients.\nParameters of IEEE Std 421.5 Type AC1A. EXAC1 in PSSE and PSLF","struct_name":"EXAC1","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input filter time constant in s","valid_range":{"max":0.5,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator denominator (lag) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Tc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator numerator (lead) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"comment":"Regulator output gain","valid_range":{"max":1000,"min":0}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator output time constant in s","valid_range":{"max":10,"min":0}},{"name":"Va_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for regulator output `(Va_min, Va_max)`"},{"name":"Kb","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Second Stage regulator gain","valid_range":{"max":500,"min":"eps()"}},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for exciter field voltage `(Vr_min, Vr_max)`"},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Exciter field time constant","valid_range":{"max":2,"min":"eps()"}},{"name":"Kl","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter field current limiter gain","valid_range":{"max":1.1,"min":0}},{"name":"Kh","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter field current regulator feedback gain","valid_range":{"max":1.1,"min":0}},{"name":"Kf","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rate feedback excitation system stabilizer gain","valid_range":{"max":0.3,"min":0}},{"name":"Tf","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Rate feedback time constant","valid_range":{"max":null,"min":"eps()"}},{"name":"Kc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rectifier loading factor proportional to commutating reactance","valid_range":{"max":1,"min":0}},{"name":"Kd","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Demagnetizing factor, function of exciter alternator reactances","valid_range":{"max":1,"min":0}},{"name":"Ke","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter field proportional constant","valid_range":{"max":1,"min":0}},{"name":"V_lr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Maximum exciter field current","valid_range":{"max":null,"min":0}},{"name":"E_sat","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter output voltage for saturation factor: (E1, E2)"},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter saturation factor at exciter output voltage: (Se(E1), Se(E2))"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"saturation_coeffs","default":"PowerSystems.get_avr_saturation(E_sat, Se)","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Coefficients (A,B) of the function: Se(V) = B(V - A)^2/V"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVm: Sensed terminal voltage,\n\tVr1: Lead-lag state,\n\tVr2: Regulator output state,\n\tVe: Integrator output state,\n\tVr3: Feedback output state","internal_default":"[:Vm, :Vr1, :Vr2, :Ve, :Vr3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"EXAC2 has 5 states","internal_default":5},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"EXAC2 has 5 states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Modified AC2. This excitation systems consists of an alternator main exciter feeding its output via non-controlled rectifiers.\nThe exciter does not employ self-excitation, and the voltage regulator power is taken from a source that is not affected by external transients.\nParameters of IEEE Std 421.5 Type AC2A Excitacion System. The alternator main exciter is used, feeding its output via non-controlled rectifiers. The Type AC2C model is similar to that of Type AC1C except for the inclusion of exciter time constant compensation and exciter field current limiting elements. EXAC2 in PSSE and PSLF.","struct_name":"EXAC2","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input filter time constant in s","valid_range":{"max":0.5,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator output gain","valid_range":{"max":1000,"min":0}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator output lag time constant in s","valid_range":{"max":10,"min":0}},{"name":"Tk","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage Regulator lead time constant","valid_range":{"max":10,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator denominator (lag) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Tc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator numerator (lead) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Va_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for regulator output `(Va_min, Va_max)`"},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for exciter field voltage `(Vr_min, Vr_max)`"},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Exciter field time constant","valid_range":{"max":2,"min":"eps()"}},{"name":"VFE_lim","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter field current limiter reference","valid_range":{"max":20,"min":-5}},{"name":"Kh","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter field current regulator feedback gain","valid_range":{"max":100,"min":0}},{"name":"VH_max","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter field current limiter maximum output","valid_range":{"max":100,"min":0}},{"name":"Th","data_type":"Float64","null_value":0,"comment":"Exciter field current limiter denominator (lag) time constant","valid_range":{"max":1,"min":0}},{"name":"Tj","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter field current limiter numerator (lead) time constant","valid_range":{"max":1,"min":0}},{"name":"Kc","data_type":"Float64","null_value":0,"comment":"Rectifier loading factor proportional to commutating reactance","valid_range":{"max":1,"min":0}},{"name":"Kd","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Demagnetizing factor, function of exciter alternator reactances","valid_range":{"max":2,"min":0}},{"name":"Ke","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter field proportional constant","valid_range":{"max":2,"min":0}},{"name":"E_sat","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter output voltage for saturation factor: (E1, E2)"},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter saturation factor at exciter output voltage: (Se(E1), Se(E2))"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"saturation_coeffs","default":"PowerSystems.get_avr_saturation(E_sat, Se)","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Coefficients (A,B) of the function: Se(V) = B(V - A)^2/V"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVm: Sensed terminal voltage,\n\tVr1: Lead-lag state,\n\tVr2: Regulator output state,\n\tVe: Integrator output state,\n\tVr3: Feedback output state","internal_default":"[:Vm, :Vr1, :Vr2, :Ve, :Vr3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ESAC6A has 5 states","internal_default":5},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"ESAC6A has 5 states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential, StateTypes.Hybrid]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Modified AC6A. Used to represent field-controlled alternator-rectifier excitation systems with system-supplied electronic voltage regulators. \nParameters of IEEE Std 421.5 Type AC6A Excitacion System. ESAC6A in PSSE and PSLF.","struct_name":"ESAC6A","supertype":"AVR"},{"fields":[{"name":"UEL_flags","data_type":"Int","null_value":1,"validation_action":"warn","comment":"Code input for Underexcitization limiter (UEL) entry. Not supported.","valid_range":{"max":3,"min":1}},{"name":"PSS_flags","data_type":"Int","null_value":1,"comment":"Code input for Power System Stabilizer (PSS) or (VOS) entry.","valid_range":{"max":2,"min":1}},{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input filter time constant in s","valid_range":{"max":0.1,"min":0}},{"name":"Vi_lim","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Voltage error limits (regulator input) (Vi_min, Vi_max)"},{"name":"Tc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"First regulator denominator (lead) time constant in s","valid_range":{"max":10,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"comment":"First regulator denominator (lag) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Tc1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Second regulator denominator (lead) time constant in s","valid_range":{"max":10,"min":0}},{"name":"Tb1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Second regulator denominator (lead) time constant in s","valid_range":{"max":20,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage regulator gain","valid_range":{"max":1000,"min":50}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage regulator time constant in s","valid_range":{"max":0.5,"min":0}},{"name":"Va_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for regulator output `(Va_min, Va_max)`"},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for exciter output `(Vr_min, Vr_max)`"},{"name":"Kc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rectifier loading factor proportional to commutating reactance","valid_range":{"max":0.3,"min":0}},{"name":"Kf","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rate feedback gain","valid_range":{"max":0.3,"min":0}},{"name":"Tf","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Rate feedback time constant in s","valid_range":{"max":1.5,"min":"eps()"}},{"name":"K_lr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter output current limiter gain","valid_range":{"max":5,"min":0}},{"name":"I_lr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter output current limit reference","valid_range":{"max":5,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVm: Sensed terminal voltage,\n\tVr1: First Lead-lag state,\n\tVr2: Second lead-lag state,\n\tVa: Regulator output state,\n\tVr3: Feedback output state","internal_default":"[:Vm, :Vr1, :Vr2, :Va, :Vr3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ST1A has 5 states","internal_default":5},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"ST1A has 5 states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"This excitation system supplies power through a transformer from the generator terminals and its regulated by a controlled rectifier (via thyristors).\nParameters of IEEE Std 421.5 Type ST1A Excitacion System. ESST1A in PSSE and PSLF","struct_name":"ESST1A","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input filter time constant in s","valid_range":{"max":0.5,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage regulator gain","valid_range":{"max":500,"min":1}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage regulator time constant in s","valid_range":{"max":10,"min":0}},{"name":"Va_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for pi controler `(Vr_min, Vr_max)`"},{"name":"Ta_2","data_type":"Float64","null_value":0,"comment":"Voltage regulator time constant in s","valid_range":{"max":null,"min":0}},{"name":"Ta_3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage regulator time constant in s","valid_range":{"max":null,"min":0}},{"name":"Ta_4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage regulator time constant in s","valid_range":{"max":null,"min":0}},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Voltage regulator limits (regulator output) (Vi_min, Vi_max)"},{"name":"Kf","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rate feedback gain","valid_range":{"max":0.3,"min":0}},{"name":"Tf_1","validation_actions":"error","data_type":"Float64","null_value":0,"comment":"Rate Feedback time constant in s","valid_range":{"max":15,"min":"eps()"}},{"name":"Tf_2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rate Feedback time constant in s","valid_range":{"max":5,"min":0}},{"name":"Efd_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Field Voltage regulator limits (regulator output) (Efd_min, Efd_max)"},{"name":"Ke","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter constant","valid_range":{"max":1,"min":0}},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter time constant","valid_range":{"max":2,"min":0}},{"name":"E_sat","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter output voltage for saturation factor: (E1, E2)"},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Exciter saturation factor at exciter output voltage: (Se(E1), Se(E2))"},{"name":"Kp","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Potential source gain","valid_range":{"max":5,"min":0}},{"name":"Ki","data_type":"Float64","null_value":0,"comment":"current source gain","valid_range":{"max":1.1,"min":0}},{"name":"Kc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter regulation factor","valid_range":{"max":2,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"saturation_coeffs","default":"PowerSystems.get_avr_saturation(E_sat, Se)","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Coefficients (A,B) of the function: Se(V) = B(V - A)^2/V"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVm: Sensed terminal voltage,\n\tVr1: First Lead-lag state,\n\tVr2: Second regulator lead-lag state,\n\tVr2: Third regulator lead-lag state \n\tVf: Exciter output \n\tVr3: First feedback integrator,\n\tVr4: second feedback integrator","internal_default":"[:Vm, :Vr1, :Vr2, :Vf, :Vr3, :Vr4]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"EXPIC1 has 6 states","internal_default":6},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"EXPIC has 6 states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential, StateTypes.Hybrid]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Generic Proportional/Integral Excitation System","struct_name":"EXPIC1","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator input filter time constant in s","valid_range":{"max":0.5,"min":0}},{"name":"K_pr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator propotional gain","valid_range":{"max":75,"min":0}},{"name":"K_ir","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Regulator integral gain","valid_range":{"max":75,"min":0}},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Voltage regulator limits (Vi_min, Vi_max)"},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage regulator time constant in s","valid_range":{"max":1,"min":0}},{"name":"K_pm","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage regulator proportional gain output","valid_range":{"max":1.2,"min":0}},{"name":"K_im","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage regulator integral gain output","valid_range":{"max":18,"min":0}},{"name":"Vm_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for inner loop output `(Vm_min, Vm_max)`"},{"name":"Kg","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Feedback gain constant of the inner loop field regulator","valid_range":{"max":1.1,"min":0}},{"name":"Kp","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Potential circuit (voltage) gain coefficient","valid_range":{"max":10,"min":0}},{"name":"Ki","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Compound circuit (current) gain coefficient","valid_range":{"max":1.1,"min":0}},{"name":"VB_max","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Maximum available exciter voltage","valid_range":{"max":20,"min":1}},{"name":"Kc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Rectifier loading factor proportional to commutating reactance","valid_range":{"max":1,"min":0}},{"name":"Xl","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Reactance associated with potential source","valid_range":{"max":0.5,"min":0}},{"name":"θp","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Potential circuit phase angle (degrees)","valid_range":{"max":90,"min":-90}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"θp_rad","default":"θp*π*inv(180)","data_type":"Float64","null_value":0,"comment":"Potential circuit phase angle (radians)"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVm: Sensed terminal voltage,\n\tVt: Sensed Terminal Voltage,\n\tVr1: Regulator Integrator,\n\tVr2: Regulator Output,\n\tVm: Output integrator","internal_default":"[:Vt, :Vr1, :Vr2, :Vm]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ST4B has 4 states","internal_default":4},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"ST4B has 4 states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"In these excitation systems, voltage (and also current in compounded systems) is transformed to an appropriate level. Rectifiers, either controlled or non-controlled, provide the necessary direct current for the generator field.\nParameters of IEEE Std 421.5 Type ST4B Excitacion System. ESST4B in PSSE and PSLF","struct_name":"ESST4B","supertype":"AVR"},{"fields":[{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Voltage Measurement Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Vi_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Voltage input limits (Vi_min, Vi_max)"},{"name":"Tc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Numerator lead-lag (lead) time constant in s","valid_range":{"max":null,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Denominator lead-lag (lag) time constant in s","valid_range":{"max":null,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Amplifier Gain","valid_range":{"max":null,"min":0}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Amplifier Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"Vr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Voltage regulator limits (regulator output) (Vr_min, Vr_max)"},{"name":"Kc","data_type":"Float64","null_value":0,"comment":"Current field constant limiter multiplier","valid_range":{"max":null,"min":0}},{"name":"Kf","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Excitation control system stabilizer gain","valid_range":{"max":0.3,"min":"eps()"}},{"name":"Tf","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Excitation control system stabilizer time constant","valid_range":{"max":null,"min":"eps()"}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVm: Sensed Terminal Voltage,\n\tVrll: Lead-Lag state,\n\tVr: Regulator Output, \n\tVfb: Feedback state","internal_default":"[:Vm, :Vrll, :Vr, :Vfb]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The EXST1 has 4 states","internal_default":4},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"IEEE Type ST1 Excitation System (PTI version)","struct_name":"EXST1","supertype":"AVR"},{"fields":[{"name":"Iflim","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"OEL Field current limit","valid_range":{"max":null,"min":0}},{"name":"d","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"OEL parameter d","valid_range":{"max":null,"min":0}},{"name":"f","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"OEL parameter f","valid_range":{"max":null,"min":0}},{"name":"Spar","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"OEL parameter Spar","valid_range":{"max":null,"min":0}},{"name":"K1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"OEL delay time constant","valid_range":{"max":null,"min":0}},{"name":"K2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"OEL parameter K2","valid_range":{"max":null,"min":0}},{"name":"Oel_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Oel integrator limits (Oel_min, Oel_max)"},{"name":"G","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"AVR Exciter Gain","valid_range":{"max":null,"min":0}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Numerator lead-lag (lag) time constant in s","valid_range":{"max":null,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Denominator lead-lag (lag) time constant in s","valid_range":{"max":null,"min":0}},{"name":"Te","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Exciter Time Constant in s","valid_range":{"max":null,"min":0}},{"name":"E_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Voltage regulator limits (regulator output) (E_min, E_max)"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tVll: Lead-lag internal state,\n\tVex: Exciter Output, \n\toel: OEL integrator state","internal_default":"[:Vll, :Vex, :oel]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The EX4VSA has 3 states","internal_default":3},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"IEEE Excitation System for Voltage Security Assesment","struct_name":"EX4VSA","supertype":"AVR"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Resistance after EMF in machine per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_p","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in machine per unit","valid_range":{"max":null,"min":0}},{"name":"eq_p","data_type":"Float64","null_value":0,"comment":"Fixed EMF behind the impedance","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"BaseMachine has no states","internal_default":"Vector{Symbol}()"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"BaseMachine has no states","internal_default":0},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of a Classic Machine: GENCLS in PSSE and PSLF","struct_name":"BaseMachine","supertype":"Machine"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Armature resistance","valid_range":{"max":null,"min":0}},{"name":"Td0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Td0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Xd","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in d-axis per unit. Note: Xd_pp = Xq_pp","valid_range":{"max":null,"min":0}},{"name":"Xl","data_type":"Float64","null_value":0,"comment":"Stator leakage reactance","valid_range":{"max":null,"min":0}},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Saturation factor at 1 and 1.2 pu flux: S(1.0) = B(|ψ_pp|-A)^2"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"γ_d1","data_type":"Float64","comment":"γ_d1 parameter","internal_default":"(Xd_pp - Xl) / (Xd_p - Xl)"},{"name":"γ_q1","data_type":"Float64","comment":"γ_q1 parameter","internal_default":"(Xd_pp - Xl) / (Xq_p - Xl)"},{"name":"γ_d2","data_type":"Float64","comment":"γ_d2 parameter","internal_default":"(Xd_p - Xd_pp) / (Xd_p - Xl)^2"},{"name":"γ_q2","data_type":"Float64","comment":"γ_q2 parameter","internal_default":"(Xq_p - Xd_pp) / (Xq_p - Xl)^2"},{"name":"γ_qd","data_type":"Float64","comment":"γ_qd parameter","internal_default":"(Xq - Xl) / (Xd - Xl)"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\teq_p: q-axis generator voltage behind the transient reactance,\n\ted_p: d-axis generator voltage behind the transient reactance,\n\tψ_kd: flux linkage in the first equivalent damping circuit in the d-axis,\n\tψ_kq: flux linkage in the first equivalent damping circuit in the d-axis","internal_default":"[:eq_p, :ed_p, :ψ_kd, :ψ_kq]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"RoundRotorMachine has 4 states","internal_default":4},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 4-states round-rotor synchronous machine with quadratic/exponential saturation:\nIEEE Std 1110 §5.3.2 (Model 2.2). GENROU or GENROE model in PSSE and PSLF.","struct_name":"RoundRotorMachine","supertype":"Machine"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Armature resistance","valid_range":{"max":null,"min":0}},{"name":"Td0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Td0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Xd","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in d-axis per unit. Note: Xd_pp = Xq_pp","valid_range":{"max":null,"min":0}},{"name":"Xl","data_type":"Float64","null_value":0,"comment":"Stator leakage reactance","valid_range":{"max":null,"min":0}},{"name":"Se","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Saturation factor at 1 and 1.2 pu flux: Se(eq_p) = B(eq_p-A)^2"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"γ_d1","data_type":"Float64","comment":"γ_d1 parameter","internal_default":"(Xd_pp - Xl) / (Xd_p - Xl)"},{"name":"γ_q1","data_type":"Float64","comment":"γ_q1 parameter","internal_default":"(Xd_p - Xd_pp) / (Xd_p - Xl)"},{"name":"γ_d2","data_type":"Float64","comment":"γ_d2 parameter","internal_default":"(Xd_p - Xd_pp) / (Xd_p - Xl)^2"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\teq_p: q-axis generator voltage behind the transient reactance,\n\tψ_kd: flux linkage in the first equivalent damping circuit in the d-axis,\n\tψq_pp: phasonf of the subtransient flux linkage in the q-axis","internal_default":"[:eq_p, :ψ_kd, :ψq_pp]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"SalientPoleMachine has 3 states","internal_default":3},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 3-states salient-pole synchronous machine with quadratic/exponential saturation:\nIEEE Std 1110 §5.3.1 (Model 2.1). GENSAL or GENSAE model in PSSE and PSLF.","struct_name":"SalientPoleMachine","supertype":"Machine"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Resistance after EMF in machine per unit","valid_range":{"max":null,"min":0}},{"name":"Xd","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Td0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Td0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tψq: q-axis stator flux,\n\tψd: d-axis stator flux,\n\teq_p: q-axis transient voltage,\n\ted_p: d-axis transient voltage,\n\teq_pp: q-axis subtransient voltage,\n\ted_pp: d-axis subtransient voltage","internal_default":"[:ψq, :ψd, :eq_p, :ed_p, :eq_pp, :ed_pp]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"AndersonFouadMachine has 6 states","internal_default":6},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 6-states synchronous machine: Anderson-Fouad model","struct_name":"AndersonFouadMachine","supertype":"Machine"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Resistance after EMF in machine per unit","valid_range":{"max":null,"min":0}},{"name":"R_f","data_type":"Float64","null_value":0,"comment":"Field rotor winding resistance in per unit","valid_range":{"max":null,"min":0}},{"name":"R_1d","data_type":"Float64","null_value":0,"comment":" Damping rotor winding resistance on d-axis in per unit. This value is denoted as RD in Machowski.","valid_range":{"max":null,"min":0}},{"name":"R_1q","data_type":"Float64","null_value":0,"comment":"Damping rotor winding resistance on q-axis in per unit. This value is denoted as RQ in Machowski.","valid_range":{"max":null,"min":0}},{"name":"L_d","data_type":"Float64","null_value":1,"comment":"Inductance of fictitious damping that represent the effect of the three-phase stator winding in the d-axis of the rotor, in per unit. This value is denoted as L_ad + L_l in Kundur (and Ld in Machowski).","valid_range":{"max":null,"min":0}},{"name":"L_q","data_type":"Float64","null_value":1,"comment":"Inductance of fictitious damping that represent the effect of the three-phase stator winding in the q-axis of the rotor, in per unit. This value is denoted as L_aq + L_l in Kundur.","valid_range":{"max":null,"min":0}},{"name":"L_ad","data_type":"Float64","null_value":2,"comment":"Mutual inductance between stator winding and rotor field (and damping) winding inductance on d-axis, in per unit","valid_range":{"max":null,"min":0}},{"name":"L_aq","data_type":"Float64","null_value":2,"comment":"Mutual inductance between stator winding and rotor damping winding inductance on q-axis, in per unit","valid_range":{"max":null,"min":0}},{"name":"L_f1d","data_type":"Float64","null_value":1,"comment":"Mutual inductance between rotor field winding and rotor damping winding inductance on d-axis, in per unit","valid_range":{"max":null,"min":0}},{"name":"L_ff","data_type":"Float64","null_value":2,"comment":"Field rotor winding inductance, in per unit","valid_range":{"max":null,"min":0}},{"name":"L_1d","data_type":"Float64","null_value":1,"comment":"Inductance of the d-axis rotor damping circuit, in per unit","valid_range":{"max":null,"min":0}},{"name":"L_1q","data_type":"Float64","null_value":1,"comment":"Inductance of the q-axis rotor damping circuit, in per unit","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"inv_d_fluxlink","data_type":"Array{Float64,2}","comment":"Equations 3.127, 3.130, 3.131 From Kundur","internal_default":"inv([[-L_d L_ad L_ad]; [-L_ad L_ff L_f1d]; [-L_ad L_f1d L_1d]])"},{"name":"inv_q_fluxlink","data_type":"Array{Float64,2}","comment":"Equations 3.128, 3.132 From Kundur","internal_default":"inv([[-L_q L_aq]; [-L_aq L_1q]])"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tψd: d-axis stator flux,\n\tψq: q-axis stator flux,\n\tψf: field rotor flux,\n\tψ1d: d-axis rotor damping flux,\n\tψ1q: q-axis rotor damping flux","internal_default":"[:ψd, :ψq, :ψf, :ψ1d, :ψ1q]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"FullMachine has 5 states","internal_default":5},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameter of a full order flux stator-rotor model without zero sequence flux in the stator.\n The derivative of stator fluxes (ψd and ψq) is NOT neglected. Only one q-axis damping circuit is considered. All parameters are in machine per unit.\n Refer to Chapter 3 of Power System Stability and Control by P. Kundur or Chapter 11 of Power System Dynamics: Stability and Control, by J. Machowski, J. Bialek and J. Bumby, for more details.\n Note that the models are somewhat different (but equivalent) due to the different Park Transformation used in both books.","struct_name":"FullMachine","supertype":"Machine"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Resistance after EMF in machine per unit","valid_range":{"max":null,"min":0}},{"name":"Xd","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xl","data_type":"Float64","null_value":0,"comment":"Stator Leakage Reactance","valid_range":{"max":null,"min":0}},{"name":"Td0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Td0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"γ_d1","data_type":"Float64","comment":"","internal_default":"(Xd_pp-Xl)/(Xd_p-Xl)"},{"name":"γ_q1","data_type":"Float64","comment":"","internal_default":"(Xq_pp-Xl)/(Xq_p-Xl)"},{"name":"γ_d2","data_type":"Float64","comment":"","internal_default":"(Xd_p - Xd_pp) / (Xd_p - Xl)^2"},{"name":"γ_q2","data_type":"Float64","comment":"","internal_default":"(Xq_p - Xq_pp) / (Xq_p - Xl)^2"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tψq: q-axis stator flux,\n\tψd: d-axis stator flux,\n\teq_p: q-axis transient voltage,\n\ted_p: d-axis transient voltage\n\tψd_pp: subtransient flux linkage in the d-axis\n\tψq_pp: subtransient flux linkage in the q-axis","internal_default":"[:ψq, :ψd, :eq_p, :ed_p, :ψd_pp, :ψq_pp]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"SauerPaiMachine has 6 states","internal_default":6},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of synchronous machine: Sauer Pai model","struct_name":"SauerPaiMachine","supertype":"Machine"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Resistance after EMF in machine per unit","valid_range":{"max":null,"min":0}},{"name":"Xd","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Td0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Td0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"T_AA","data_type":"Float64","null_value":0,"comment":"Time constant of d-axis additional leakage","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"γd","data_type":"Float64","comment":"","internal_default":"((Td0_pp*Xd_pp)/(Td0_p*Xd_p) )*(Xd-Xd_p)"},{"name":"γq","data_type":"Float64","comment":"","internal_default":"((Tq0_pp*Xq_pp)/(Tq0_p*Xq_p) )*(Xq-Xq_p)"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tψq: q-axis stator flux,\n\tψd: d-axis stator flux,\n\teq_p: q-axis transient voltage,\n\ted_p: d-axis transient voltage,\n\teq_pp: q-axis subtransient voltage,\n\ted_pp: d-axis subtransient voltage","internal_default":"[:ψq, :ψd, :eq_p, :ed_p, :eq_pp, :ed_pp]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"MarconatoMachine has 6 states","internal_default":6},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 6-states synchronous machine: Marconato model","struct_name":"MarconatoMachine","supertype":"Machine"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Resistance after EMF in machine per unit","valid_range":{"max":null,"min":0}},{"name":"Xd","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Td0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\teq_p: q-axis transient voltage,\n\ted_p: d-axis transient voltage","internal_default":"[:eq_p, :ed_p]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"OneDOneQMachine has 2 states","internal_default":2},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 4-states synchronous machine: Simplified Marconato model\n The derivative of stator fluxes (ψd and ψq) is neglected and ωψd = ψd and\n ωψq = ψq is assumed (i.e. ω=1.0). This is standard when\n transmission network dynamics is neglected.","struct_name":"OneDOneQMachine","supertype":"Machine"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Resistance after EMF in machine per unit","valid_range":{"max":null,"min":0}},{"name":"Xd","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Td0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Td0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\teq_p: q-axis transient voltage,\n\ted_p: d-axis transient voltage,\n\teq_pp: q-axis subtransient voltage,\n\ted_pp: d-axis subtransient voltage","internal_default":"[:eq_p, :ed_p, :eq_pp, :ed_pp]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"SimpleAFMachine has 4 states","internal_default":4},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 4-states simplified Anderson-Fouad (SimpleAFMachine) model.\n The derivative of stator fluxes (ψd and ψq) is neglected and ωψd = ψd and\n ωψq = ψq is assumed (i.e. ω=1.0). This is standard when transmission network\n dynamics is neglected.\n If transmission dynamics is considered use the full order Anderson Fouad model.","struct_name":"SimpleAFMachine","supertype":"Machine"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Resistance after EMF in machine per unit","valid_range":{"max":null,"min":0}},{"name":"R_f","data_type":"Float64","null_value":0,"comment":"Field rotor winding resistance in per unit","valid_range":{"max":null,"min":0}},{"name":"R_1d","data_type":"Float64","null_value":0,"comment":" Damping rotor winding resistance on d-axis in per unit. This value is denoted as RD in Machowski.","valid_range":{"max":null,"min":0}},{"name":"R_1q","data_type":"Float64","null_value":0,"comment":"Damping rotor winding resistance on q-axis in per unit. This value is denoted as RQ in Machowski.","valid_range":{"max":null,"min":0}},{"name":"L_d","data_type":"Float64","null_value":1,"comment":"Inductance of fictitious damping that represent the effect of the three-phase stator winding in the d-axis of the rotor, in per unit. This value is denoted as L_ad + L_l in Kundur (and Ld in Machowski).","valid_range":{"max":null,"min":0}},{"name":"L_q","data_type":"Float64","null_value":1,"comment":"Inductance of fictitious damping that represent the effect of the three-phase stator winding in the q-axis of the rotor, in per unit. This value is denoted as L_aq + L_l in Kundur.","valid_range":{"max":null,"min":0}},{"name":"L_ad","data_type":"Float64","null_value":2,"comment":"Mutual inductance between stator winding and rotor field (and damping) winding inductance on d-axis, in per unit","valid_range":{"max":null,"min":0}},{"name":"L_aq","data_type":"Float64","null_value":1,"comment":"Mutual inductance between stator winding and rotor damping winding inductance on q-axis, in per unit","valid_range":{"max":null,"min":0}},{"name":"L_f1d","data_type":"Float64","null_value":1,"comment":"Mutual inductance between rotor field winding and rotor damping winding inductance on d-axis, in per unit","valid_range":{"max":null,"min":0}},{"name":"L_ff","data_type":"Float64","null_value":2,"comment":"Field rotor winding inductance, in per unit","valid_range":{"max":null,"min":0}},{"name":"L_1d","data_type":"Float64","null_value":1,"comment":"Inductance of the d-axis rotor damping circuit, in per unit","valid_range":{"max":null,"min":0}},{"name":"L_1q","data_type":"Float64","null_value":2,"comment":"Inductance of the q-axis rotor damping circuit, in per unit","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"inv_d_fluxlink","data_type":"Array{Float64,2}","comment":"Equations 3.127, 3.130, 3.131 From Kundur","internal_default":"inv([[-L_d L_ad L_ad]; [-L_ad L_ff L_f1d]; [-L_ad L_f1d L_1d]])"},{"name":"inv_q_fluxlink","data_type":"Array{Float64,2}","comment":"Equations 3.128, 3.132 From Kundur","internal_default":"inv([[-L_q L_aq]; [-L_aq L_1q]])"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tψf: field rotor flux,\n\tψ1d: d-axis rotor damping flux,\n\tψ1q: q-axis rotor damping flux","internal_default":"[:ψf, :ψ1d, :ψ1q]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"SimpleFullMachine has 3 states","internal_default":3},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameter of a full order flux stator-rotor model without zero sequence flux in the stator.\n The derivative of stator fluxes (ψd and ψq) is neglected. This is standard when\n transmission network dynamics is neglected. Only one q-axis damping circuit\n is considered. All per unit are in machine per unit.\n Refer to Chapter 3 of Power System Stability and Control by P. Kundur or Chapter 11 of Power System Dynamics: Stability and Control, by J. Machowski, J. Bialek and J. Bumby, for more details.\n Note that the models are somewhat different (but equivalent) due to the different Park Transformation used in both books.","struct_name":"SimpleFullMachine","supertype":"Machine"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Resistance after EMF in machine per unit","valid_range":{"max":null,"min":0}},{"name":"Xd","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq","data_type":"Float64","null_value":0,"comment":"Reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_p","data_type":"Float64","null_value":0,"comment":"Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xd_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in d-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Xq_pp","data_type":"Float64","null_value":0,"comment":"Sub-Transient reactance after EMF in q-axis per unit","valid_range":{"max":null,"min":0}},{"name":"Td0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_p","data_type":"Float64","null_value":0,"comment":"Time constant of transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Td0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient d-axis voltage","valid_range":{"max":null,"min":0}},{"name":"Tq0_pp","data_type":"Float64","null_value":0,"comment":"Time constant of sub-transient q-axis voltage","valid_range":{"max":null,"min":0}},{"name":"T_AA","data_type":"Float64","null_value":0,"comment":"Time constant of d-axis additional leakage","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"γd","data_type":"Float64","comment":"","internal_default":"((Td0_pp*Xd_pp)/(Td0_p*Xd_p) )*(Xd-Xd_p)"},{"name":"γq","data_type":"Float64","comment":"","internal_default":"((Tq0_pp*Xq_pp)/(Tq0_p*Xq_p) )*(Xq-Xq_p)"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\teq_p: q-axis transient voltage,\n\ted_p: d-axis transient voltage,\n\teq_pp: q-axis subtransient voltage,\n\ted_pp: d-axis subtransient voltage","internal_default":"[:eq_p, :ed_p, :eq_pp, :ed_pp]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"SimpleMarconatoMachine has 4 states","internal_default":4},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 4-states synchronous machine: Simplified Marconato model\n The derivative of stator fluxes (ψd and ψq) is neglected and ωψd = ψd and\n ωψq = ψq is assumed (i.e. ω=1.0). This is standard when transmission network\n dynamics is neglected.","struct_name":"SimpleMarconatoMachine","supertype":"Machine"},{"fields":[{"name":"V_pss","data_type":"Float64","null_value":0,"comment":"Fixed voltage stabilization signal","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"","internal_default":"Vector{Symbol}()"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"PSSFixed has no states","internal_default":0},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of a PSS that returns a fixed voltage to add to the reference for the AVR","struct_name":"PSSFixed","supertype":"PSS"},{"fields":[{"name":"K_ω","data_type":"Float64","null_value":0,"comment":"Proportional gain for frequency","valid_range":{"max":null,"min":0}},{"name":"K_p","data_type":"Float64","null_value":0,"comment":"Proportional gain for active power","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"","internal_default":"Vector{Symbol}()"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"PSSSimple has no states","internal_default":0},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of a PSS that returns a proportional droop voltage to add to the reference for the AVR","struct_name":"PSSSimple","supertype":"PSS"},{"fields":[{"name":"input_code","data_type":"Int","null_value":1,"validation_action":"error","comment":"Code input for stabilizer","valid_range":{"max":6,"min":1}},{"name":"remote_bus_control","data_type":"Int","null_value":0,"comment":"Remote Bus number for control."},{"name":"A1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Filter coefficient","valid_range":{"max":null,"min":0}},{"name":"A2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Filter coefficient","valid_range":{"max":null,"min":0}},{"name":"A3","data_type":"Float64","null_value":0,"comment":"Filter coefficient","valid_range":{"max":null,"min":0}},{"name":"A4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Filter coefficient","valid_range":{"max":null,"min":0}},{"name":"A5","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Filter coefficient","valid_range":{"max":null,"min":0}},{"name":"A6","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Filter coefficient","valid_range":{"max":null,"min":0}},{"name":"T1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant","valid_range":{"max":10,"min":0}},{"name":"T2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant","valid_range":{"max":10,"min":0}},{"name":"T3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant","valid_range":{"max":10,"min":0}},{"name":"T4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant","valid_range":{"max":10,"min":0}},{"name":"T5","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant","valid_range":{"max":10,"min":0}},{"name":"T6","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Time constant","valid_range":{"max":"2.0","min":"eps()"}},{"name":"Ks","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Proportional gain","valid_range":{"max":null,"min":0}},{"name":"Ls_lim","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"PSS output limits for regulator output `(Ls_min, Ls_max)`"},{"name":"Vcu","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Cutoff limiter upper bound","valid_range":{"max":"1.25","min":0}},{"name":"Vcl","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Cutoff limiter lower bound","valid_range":{"max":"1.0","min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tx_p1: 1st filter integration,\n\tx_p2: 2nd filter integration, \n\tx_p3: 3rd filter integration, \n\tx_p4: 4rd filter integration, \n\tx_p5: T1/T2 lead-lag integrator, \n\tx_p6: T3/T4 lead-lag integrator, \n\t:x_p7 last integer,","internal_default":"[:x_p1, :x_p2, :x_p3, :x_p4, :x_p5, :x_p6, :x_p7]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"IEEEST has 7 states","internal_default":7},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"IEEEST has 7 differential states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"IEEE Stabilizing Model PSS. ","struct_name":"IEEEST","supertype":"PSS"},{"fields":[{"name":"KT","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"K/T for washout filter","valid_range":{"max":null,"min":0}},{"name":"T","data_type":"Float64","null_value":0.01,"validation_action":"warn","comment":"Time constant for washout filter","valid_range":{"max":null,"min":0.01}},{"name":"T1T3","data_type":"Float64","null_value":0,"comment":"Time constant division T1/T3","valid_range":{"max":null,"min":0}},{"name":"T3","data_type":"Float64","null_value":0.01,"validation_action":"warn","comment":"Time constant","valid_range":{"max":null,"min":0.01}},{"name":"T2T4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant division T2/T4","valid_range":{"max":null,"min":0}},{"name":"T4","data_type":"Float64","null_value":0.01,"validation_action":"warn","comment":"Time constant","valid_range":{"max":null,"min":0.01}},{"name":"H_lim","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"PSS output limit","valid_range":{"max":0.5,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tx_p1: washout filter,\n\tx_p2: T1/T3 lead-lag block, \n\tx_p3: T2/T4 lead-lag block,","internal_default":"[:x_p1, :x_p2, :x_p3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"STAB1 has 3 states","internal_default":3},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"STAB1 has 3 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Speed-Sensitive Stabilizing Model","struct_name":"STAB1","supertype":"PSS"},{"fields":[{"name":"input_code_1","data_type":"Int","null_value":1,"validation_action":"error","comment":"First Input Code for stabilizer","valid_range":{"max":6,"min":1}},{"name":"remote_bus_control_1","data_type":"Int","null_value":0,"comment":"First Input Remote Bus number for control."},{"name":"input_code_2","data_type":"Int","null_value":1,"validation_action":"error","comment":"Second Input Code for stabilizer","valid_range":{"max":6,"min":1}},{"name":"remote_bus_control_2","data_type":"Int","null_value":0,"comment":"Second Input Remote Bus number for control."},{"name":"M_rtf","data_type":"Int","null_value":0,"validation_action":"error","comment":"M parameter for ramp tracking filter","valid_range":{"max":8,"min":0}},{"name":"N_rtf","data_type":"Int","null_value":0,"validation_action":"error","comment":"N parameter for ramp tracking filter","valid_range":{"max":8,"min":0}},{"name":"Tw1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first washout filter for first input","valid_range":{"max":null,"min":"eps()"}},{"name":"Tw2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second washout filter for first input","valid_range":{"max":null,"min":0}},{"name":"T6","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for low-pass filter for first input","valid_range":{"max":null,"min":0}},{"name":"Tw3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first washout filter for second input","valid_range":{"max":null,"min":"eps()"}},{"name":"Tw4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second washout filter for second input","valid_range":{"max":null,"min":0}},{"name":"T7","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for low-pass filter for second input","valid_range":{"max":null,"min":0}},{"name":"Ks2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Gain for low-pass filter for second input","valid_range":{"max":null,"min":0}},{"name":"Ks3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Gain for second input","valid_range":{"max":null,"min":0}},{"name":"T8","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for ramp tracking filter","valid_range":{"max":null,"min":0}},{"name":"T9","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for ramp tracking filter","valid_range":{"max":null,"min":"eps()"}},{"name":"Ks1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Gain before lead-lag blocks","valid_range":{"max":null,"min":0}},{"name":"T1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second lead-lag block","valid_range":{"max":null,"min":0}},{"name":"Vst_lim","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"PSS output limits `(Vst_min, Vst_max)`"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tx_p1: 1st washout 1st input, \n\tx_p2: 2nd washout 1st input, \n\tx_p3: transducer 1st input, \n\tx_p4: 1st washout 2nd input, \n\tx_p5: 2nd washout 2nd input, \n\tx_p6: transducer 2nd input, \n\tx_p7: ramp tracking filter state 1, \n\tx_p8: ramp tracking filter state 2, \n\tx_p9: ramp tracking filter state 3, \n\tx_p10: ramp tracking filter state 4, \n\tx_p11: ramp tracking filter state 5, \n\tx_p12: ramp tracking filter state 6, \n\tx_p13: ramp tracking filter state 7, \n\tx_p14: ramp tracking filter state 8, \n\tx_p15: 1st lead-lag, \n\tx_p16: 2nd lead-lag,","internal_default":"[:x_p1, :x_p2, :x_p3, :x_p4, :x_p5, :x_p6, :x_p7, :x_p8, :x_p9, :x_p10, :x_p11, :x_p12, :x_p13, :x_p14, :x_p15, :x_p16]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"IEEEST has 16 states","internal_default":16},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"IEEEST has 16 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"IEEE Dual-Input Stabilizer Model","struct_name":"PSS2A","supertype":"PSS"},{"fields":[{"name":"input_code_1","data_type":"Int","null_value":1,"validation_action":"error","comment":"First Input Code for stabilizer","valid_range":{"max":6,"min":1}},{"name":"remote_bus_control_1","data_type":"Int","null_value":0,"comment":"First Input Remote Bus number for control."},{"name":"input_code_2","data_type":"Int","null_value":1,"validation_action":"error","comment":"Second Input Code for stabilizer","valid_range":{"max":6,"min":1}},{"name":"remote_bus_control_2","data_type":"Int","null_value":0,"comment":"Second Input Remote Bus number for control."},{"name":"M_rtf","data_type":"Int","null_value":0,"validation_action":"error","comment":"M parameter for ramp tracking filter","valid_range":{"max":8,"min":0}},{"name":"N_rtf","data_type":"Int","null_value":0,"validation_action":"error","comment":"N parameter for ramp tracking filter","valid_range":{"max":8,"min":0}},{"name":"Tw1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first washout filter for first input","valid_range":{"max":null,"min":"eps()"}},{"name":"Tw2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second washout filter for first input","valid_range":{"max":null,"min":0}},{"name":"T6","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for low-pass filter for first input","valid_range":{"max":null,"min":0}},{"name":"Tw3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first washout filter for second input","valid_range":{"max":null,"min":"eps()"}},{"name":"Tw4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second washout filter for second input","valid_range":{"max":null,"min":0}},{"name":"T7","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for low-pass filter for second input","valid_range":{"max":null,"min":0}},{"name":"Ks2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Gain for low-pass filter for second input","valid_range":{"max":null,"min":0}},{"name":"Ks3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Gain for second input","valid_range":{"max":null,"min":0}},{"name":"T8","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for ramp tracking filter","valid_range":{"max":null,"min":0}},{"name":"T9","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for ramp tracking filter","valid_range":{"max":null,"min":"eps()"}},{"name":"Ks1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Gain before lead-lag blocks","valid_range":{"max":null,"min":0}},{"name":"T1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T10","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for third lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T11","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for third lead-lag block","valid_range":{"max":null,"min":0}},{"name":"Vs1_lim","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"First input limits `(Vs1_min, Vs1_max)`"},{"name":"Vs2_lim","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Second input limits `(Vs2_min, Vs2_max)`"},{"name":"Vst_lim","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"PSS output limits `(Vst_min, Vst_max)`"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tx_p1: 1st washout 1st input, \n\tx_p2: 2nd washout 1st input, \n\tx_p3: transducer 1st input, \n\tx_p4: 1st washout 2nd input, \n\tx_p5: 2nd washout 2nd input, \n\tx_p6: transducer 2nd input, \n\tx_p7: ramp tracking filter state 1, \n\tx_p8: ramp tracking filter state 2, \n\tx_p9: ramp tracking filter state 3, \n\tx_p10: ramp tracking filter state 4, \n\tx_p11: ramp tracking filter state 5, \n\tx_p12: ramp tracking filter state 6, \n\tx_p13: ramp tracking filter state 7, \n\tx_p14: ramp tracking filter state 8, \n\tx_p15: 1st lead-lag, \n\tx_p16: 2nd lead-lag, \n\tx_p17: 3rd lead-lag,","internal_default":"[:x_p1, :x_p2, :x_p3, :x_p4, :x_p5, :x_p6, :x_p7, :x_p8, :x_p9, :x_p10, :x_p11, :x_p12, :x_p13, :x_p14, :x_p15, :x_p16, :x_p17]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"IEEEST has 17 states","internal_default":17},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"IEEEST has 17 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"IEEE 421.5 2005 PSS2B IEEE Dual-Input Stabilizer Model","struct_name":"PSS2B","supertype":"PSS"},{"fields":[{"name":"input_code_1","data_type":"Int","null_value":1,"validation_action":"error","comment":"First Input Code for stabilizer","valid_range":{"max":7,"min":1}},{"name":"remote_bus_control_1","data_type":"Int","null_value":0,"comment":"First Input Remote Bus number for control."},{"name":"input_code_2","data_type":"Int","null_value":1,"validation_action":"error","comment":"Second Input Code for stabilizer","valid_range":{"max":6,"min":1}},{"name":"remote_bus_control_2","data_type":"Int","null_value":0,"comment":"Second Input Remote Bus number for control."},{"name":"M_rtf","data_type":"Int","null_value":0,"validation_action":"error","comment":"M parameter for ramp tracking filter","valid_range":{"max":8,"min":0}},{"name":"N_rtf","data_type":"Int","null_value":0,"validation_action":"error","comment":"N parameter for ramp tracking filter","valid_range":{"max":8,"min":0}},{"name":"Tw1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first washout filter for first input","valid_range":{"max":null,"min":"eps()"}},{"name":"Tw2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second washout filter for first input","valid_range":{"max":null,"min":0}},{"name":"T6","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for low-pass filter for first input","valid_range":{"max":null,"min":0}},{"name":"Tw3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first washout filter for second input","valid_range":{"max":null,"min":"eps()"}},{"name":"Tw4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second washout filter for second input","valid_range":{"max":null,"min":0}},{"name":"T7","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for low-pass filter for second input","valid_range":{"max":null,"min":0}},{"name":"Ks2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Gain for low-pass filter for second input","valid_range":{"max":null,"min":0}},{"name":"Ks3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Gain for second input","valid_range":{"max":null,"min":0}},{"name":"T8","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for ramp tracking filter","valid_range":{"max":null,"min":0}},{"name":"T9","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for ramp tracking filter","valid_range":{"max":null,"min":"eps()"}},{"name":"Ks1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Gain before lead-lag blocks","valid_range":{"max":null,"min":0}},{"name":"T1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for first lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T10","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for third lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T11","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for third lead-lag block","valid_range":{"max":null,"min":0}},{"name":"Vs1_lim","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"First input limits `(Vs1_min, Vs1_max)`"},{"name":"Vs2_lim","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Second input limits `(Vs2_min, Vs2_max)`"},{"name":"Vst_lim","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"PSS output limits `(Vst_min, Vst_max)`"},{"name":"T12","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for fourth lead-lag block","valid_range":{"max":null,"min":0}},{"name":"T13","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for fourth lead-lag block","valid_range":{"max":null,"min":0}},{"name":"PSS_Hysteresis_param","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"PSS output hysteresis parameters `(PSSOFF, PSSON)`"},{"name":"Xcomp","data_type":"Float64","null_value":0,"comment":"Stator Leakage Reactance","valid_range":{"max":null,"min":0}},{"name":"Tcomp","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Time measured with compensated frequency","valid_range":{"max":null,"min":"eps()"}},{"name":"hysteresis_binary_logic","default":"1","data_type":"Int","null_value":0,"comment":"Hysteresis memory variable"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tx_p1: 1st washout 1st input, \n\tx_p2: 2nd washout 1st input, \n\tx_p3: transducer 1st input, \n\tx_p4: 1st washout 2nd input, \n\tx_p5: 2nd washout 2nd input, \n\tx_p6: transducer 2nd input, \n\tx_p7: ramp tracking filter state 1, \n\tx_p8: ramp tracking filter state 2, \n\tx_p9: ramp tracking filter state 3, \n\tx_p10: ramp tracking filter state 4, \n\tx_p11: ramp tracking filter state 5, \n\tx_p12: ramp tracking filter state 6, \n\tx_p13: ramp tracking filter state 7, \n\tx_p14: ramp tracking filter state 8, \n\tx_p15: 1st lead-lag, \n\tx_p16: 2nd lead-lag, \n\tx_p17: 3rd lead-lag, \n\tx_p18: 4th lead-lag, \n\tx_p19: washout block for compensated frequency,","internal_default":"[:x_p1, :x_p2, :x_p3, :x_p4, :x_p5, :x_p6, :x_p7, :x_p8, :x_p9, :x_p10, :x_p11, :x_p12, :x_p13, :x_p14, :x_p15, :x_p16, :x_p17, :x_p18, :x_p19]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"IEEEST has 19 states","internal_default":19},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"IEEEST has 19 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"IEEE 421.5 2016 PSS2C IEEE Dual-Input Stabilizer Model","struct_name":"PSS2C","supertype":"PSS"},{"fields":[{"name":"H","data_type":"Float64","null_value":0,"comment":"Rotor inertia constant in MWs/MVA","valid_range":{"max":null,"min":0}},{"name":"D","data_type":"Float64","null_value":0,"comment":"Rotor natural damping in pu","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tδ: rotor angle,\n\tω: rotor speed","internal_default":"[:δ, :ω]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"SingleMass has 1 state","internal_default":2},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of single mass shaft model. Typically represents the rotor mass.","struct_name":"SingleMass","supertype":"Shaft"},{"fields":[{"name":"H","data_type":"Float64","null_value":0,"comment":"Rotor inertia constant in MWs/MVA","valid_range":{"max":null,"min":0}},{"name":"H_hp","data_type":"Float64","null_value":0,"comment":"High pressure turbine inertia constant in MWs/MVA","valid_range":{"max":null,"min":0}},{"name":"H_ip","data_type":"Float64","null_value":0,"comment":"Intermediate pressure turbine inertia constant in MWs/MVA","valid_range":{"max":null,"min":0}},{"name":"H_lp","data_type":"Float64","null_value":0,"comment":"Low pressure turbine inertia constant in MWs/MVA","valid_range":{"max":null,"min":0}},{"name":"H_ex","data_type":"Float64","null_value":0,"comment":" Exciter inertia constant in MWs/MVA","valid_range":{"max":null,"min":0}},{"name":"D","data_type":"Float64","null_value":0,"comment":"Rotor natural damping in pu","valid_range":{"max":null,"min":0}},{"name":"D_hp","data_type":"Float64","null_value":0,"comment":"High pressure turbine natural damping in pu","valid_range":{"max":null,"min":0}},{"name":"D_ip","data_type":"Float64","null_value":0,"comment":"Intermediate pressure turbine natural damping in pu","valid_range":{"max":null,"min":0}},{"name":"D_lp","data_type":"Float64","null_value":0,"comment":"Low pressure turbine natural damping in pu","valid_range":{"max":null,"min":0}},{"name":"D_ex","data_type":"Float64","null_value":0,"comment":"Exciter natural damping in pu","valid_range":{"max":null,"min":0}},{"name":"D_12","data_type":"Float64","null_value":0,"comment":"High-Intermediate pressure turbine damping","valid_range":{"max":null,"min":0}},{"name":"D_23","data_type":"Float64","null_value":0,"comment":"Intermediate-Low pressure turbine damping","valid_range":{"max":null,"min":0}},{"name":"D_34","data_type":"Float64","null_value":0,"comment":"Low pressure turbine-Rotor damping","valid_range":{"max":null,"min":0}},{"name":"D_45","data_type":"Float64","null_value":0,"comment":"Rotor-Exciter damping","valid_range":{"max":null,"min":0}},{"name":"K_hp","data_type":"Float64","null_value":0,"comment":"High pressure turbine angle coefficient","valid_range":{"max":null,"min":0}},{"name":"K_ip","data_type":"Float64","null_value":0,"comment":"Intermediate pressure turbine angle coefficient","valid_range":{"max":null,"min":0}},{"name":"K_lp","data_type":"Float64","null_value":0,"comment":"Low pressure turbine angle coefficient","valid_range":{"max":null,"min":0}},{"name":"K_ex","data_type":"Float64","null_value":0,"comment":"Exciter angle coefficient","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\n\tδ: rotor angle,\n\tω: rotor speed,\n\tδ_hp: rotor angle of high pressure turbine,\n\tω_hp: rotor speed of high pressure turbine,\n\tδ_ip: rotor angle of intermediate pressure turbine,\n\tω_ip: rotor speed of intermediate pressure turbine,\n\tδ_lp: rotor angle of low pressure turbine,\n\tω_lp: rotor speed of low pressure turbine,\n\tδ_ex: rotor angle of exciter,\n\tω_lp: rotor speed of exciter","internal_default":"[:δ, :ω, :δ_hp, :ω_hp, :δ_ip, :ω_ip, :δ_lp, :ω_lp, :δ_ex, :ω_ex]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"FiveMassShaft has 10 states","internal_default":10},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of 5 mass-spring shaft model.\n It contains a High-Pressure (HP) steam turbine, Intermediate-Pressure (IP)\n steam turbine, Low-Pressure (LP) steam turbine, the Rotor and an Exciter (EX) mover.","struct_name":"FiveMassShaft","supertype":"Shaft"},{"fields":[{"name":"efficiency","data_type":"Float64","null_value":0,"comment":" Efficiency factor that multiplies P_ref","valid_range":{"max":null,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"","internal_default":"Vector{Symbol}()"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"TGFixed has no states","internal_default":0},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of a fixed Turbine Governor that returns a fixed mechanical torque\n given by the product of P_ref*efficiency","struct_name":"TGFixed","supertype":"TurbineGov"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Speed droop parameter","valid_range":{"max":0.1,"min":"eps()"}},{"name":"T1","data_type":"Float64","null_value":0,"comment":"Governor time constant in s","valid_range":{"max":0.5,"min":"eps()"}},{"name":"T2","data_type":"Float64","null_value":0,"comment":"Combustion chamber time constant","valid_range":{"max":0.5,"min":"eps()"}},{"name":"T3","data_type":"Float64","null_value":0,"comment":"Load limit time constant (exhaust gas measurement time)","valid_range":{"max":5,"min":"eps()"}},{"name":"AT","data_type":"Float64","null_value":0,"comment":"Ambient temperature load limit","valid_range":{"max":1,"min":0}},{"name":"Kt","data_type":"Float64","null_value":0,"comment":"Load limit feedback gain","valid_range":{"max":5,"min":0}},{"name":"V_lim","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Operational control limits on fuel valve opening (V_min, V_max)"},{"name":"D_turb","data_type":"Float64","null_value":0,"comment":"Speed damping coefficient of gas turbine rotor","valid_range":{"max":0.5,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Load Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the GAST model are:\n\tx_g1: Fuel valve opening,\n\tx_g2: Fuel flow,\n\tx_g3: Exhaust temperature load","internal_default":"[:x_g1, :x_g2, :x_g3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"GasTG has 3 states","internal_default":3},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"GAST has 3 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of Gas Turbine-Governor. GAST in PSSE and GAST_PTI in PowerWorld.","struct_name":"GasTG","supertype":"TurbineGov"},{"fields":[{"name":"T1","data_type":"Float64","null_value":0,"comment":"Governor mechanism time constant","valid_range":{"max":100,"min":"eps()"}},{"name":"T2","data_type":"Float64","null_value":0,"comment":"Turbine power time constant","valid_range":{"max":100,"min":"eps()"}},{"name":"T3","data_type":"Float64","null_value":0,"comment":"Turbine exhaust temperature time constant","valid_range":{"max":100,"min":"eps()"}},{"name":"K","data_type":"Float64","null_value":0,"comment":"Governor gain (reciprocal of droop)","valid_range":{"max":100,"min":"eps()"}},{"name":"T4","data_type":"Float64","null_value":0,"comment":"Governor lead time constant","valid_range":{"max":100,"min":"eps()"}},{"name":"T5","data_type":"Float64","null_value":0,"comment":"Governor lag time constant","valid_range":{"max":100,"min":"eps()"}},{"name":"T6","data_type":"Float64","null_value":0,"comment":"Actuator time constant","valid_range":{"max":100,"min":"eps()"}},{"name":"Td","data_type":"Float64","null_value":0,"comment":"Engine time delay","valid_range":{"max":100,"min":"eps()"}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Load Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the DEGOV model are:\n\tx_ecb1: Electric control box 1,\n\tx_ecb2: Electric control box 2,\n\tx_a1: Actuator 1,\n\tx_a2: Actuator 2,\n\tx_a3: Actuator 3,","internal_default":"[:x_ecb1, :x_ecb2, :x_a1, :x_a2, :x_a3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"DEGOV has 5 states","internal_default":5},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"DEGOV has 5 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters Woodward Diesel Governor Model. DEGOV in PowerWorld.","struct_name":"DEGOV","supertype":"TurbineGov"},{"fields":[{"name":"Rselect","data_type":"Int","null_value":1,"validation_action":"error","comment":"Feedback signal for governor droop","valid_range":{"max":1,"min":-2}},{"name":"fuel_flag","data_type":"Int","null_value":0,"validation_action":"error","comment":"Flag Switch for fuel source characteristic","valid_range":{"max":1,"min":0}},{"name":"R","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Speed droop parameter","valid_range":{"max":null,"min":"eps()"}},{"name":"Tpelec","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Electrical power transducer time constant, seconds","valid_range":{"max":null,"min":"eps()"}},{"name":"speed_error_signal","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Speed error signal limits"},{"name":"Kp_gov","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Governor proportional gain","valid_range":{"max":null,"min":0}},{"name":"Ki_gov","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Governor integral gain","valid_range":{"max":null,"min":0}},{"name":"Kd_gov","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Governor derivative gain","valid_range":{"max":null,"min":0}},{"name":"Td_gov","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Governor derivative time constant","valid_range":{"max":null,"min":0}},{"name":"valve_position_limits","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Valve position limits"},{"name":"T_act","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Actuator time constant","valid_range":{"max":null,"min":0}},{"name":"K_turb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Turbine gain","valid_range":{"max":null,"min":0}},{"name":"Wf_nl","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"No load fuel flow, pu","valid_range":{"max":null,"min":0}},{"name":"Tb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Turbine lag time constant, sec","valid_range":{"max":null,"min":0}},{"name":"Tc","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Turbine lead time constant, sec","valid_range":{"max":null,"min":0}},{"name":"T_eng","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Transport lag time constant for diesel engine, sec","valid_range":{"max":null,"min":0}},{"name":"Tf_load","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Load limiter time constant","valid_range":{"max":null,"min":0}},{"name":"Kp_load","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Load limiter proportional gain for PI controller","valid_range":{"max":null,"min":0}},{"name":"Ki_load","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Load integral gain for PI controller","valid_range":{"max":null,"min":0}},{"name":"Ld_ref","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Load limiter integral gain for PI controller","valid_range":{"max":null,"min":0}},{"name":"Dm","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Mechanical damping coefficient, pu","valid_range":{"max":null,"min":0}},{"name":"R_open","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Maximum valve opening rate, pu/sec","valid_range":{"max":null,"min":0}},{"name":"R_close","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Maximum valve closing rate, pu/sec","valid_range":{"max":null,"min":0}},{"name":"Ki_mw","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Power controller (reset) gain","valid_range":{"max":null,"min":0}},{"name":"A_set","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Acceleration limiter setpoint, pu/sec","valid_range":{"max":null,"min":0}},{"name":"Ka","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Acceleration limiter gain","valid_range":{"max":null,"min":0}},{"name":"Ta","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Acceleration limiter time constant ","valid_range":{"max":null,"min":"eps()"}},{"name":"T_rate","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Turbine rating","valid_range":{"max":null,"min":0}},{"name":"db","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Speed governor deadband","valid_range":{"max":null,"min":0}},{"name":"Tsa","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Temperature detection lead time constant","valid_range":{"max":null,"min":0}},{"name":"Tsb","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Temperature detection lag time constant","valid_range":{"max":null,"min":0}},{"name":"R_lim","data_type":"UpDown","null_value":"(up = 0.0, down = 0.0)","comment":"Maximum rate of load increa"},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the GGOV1 model are:\n\tPe: Machine Electrical Power Measurement,\n\tx_g1: Governor differential control,\n\tx_g2: Governor integral control, \n\tx_g3: Turbine actuator, \n\tx_g4: Turbine Lead-Lag, \n\tx_g5: Turbine load limiter measurement, \n\tx_g6: Turbine Load Limiter Integral Control, \n\tx_g7: Supervisory Load Control, \n\tx_g8: Acceleration Control, \n\tx_g9 Temperature Detection Lead - Lag:","internal_default":"[:Pe, :x_g1, :x_g2, :x_g3, :x_g4, :x_g5, :x_g6, :x_g7, :x_g8, :x_g9]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"GeneralGovModel has 10 states","internal_default":10},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"GGOV1 has 10 differential states","internal_default":"[StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Differential, StateTypes.Hybrid]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"GE General Governor/Turbine Model. The GeneralGovModel (GGOV1) model is a general purpose governor model used for a variety of prime movers controlled by proportional-integral-derivative (PID) governors including gas turbines.","struct_name":"GeneralGovModel","supertype":"TurbineGov"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Droop parameter","valid_range":{"max":0.1,"min":0}},{"name":"T1","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Governor time constant","valid_range":{"max":0.5,"min":"eps()"}},{"name":"valve_position_limits","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Valve position limits"},{"name":"T2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Lead Lag Lead Time constant ","valid_range":{"max":null,"min":0}},{"name":"T3","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Lead Lag Lag Time constant ","valid_range":{"max":10,"min":"eps()"}},{"name":"D_T","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Turbine Damping","valid_range":{"max":0.5,"min":0}},{"name":"DB_h","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Deadband for overspeed","valid_range":{"max":null,"min":0}},{"name":"DB_l","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Deadband for underspeed","valid_range":{"max":0,"min":null}},{"name":"T_rate","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Turbine Rate (MW). If zero, generator base is used.","valid_range":{"max":null,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the SteamTurbineGov1 model are:\n\tx_g1: Valve Opening,\n\tx_g2: Lead-lag state","internal_default":"[:x_g1, :x_g2]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"TGOV1 has 2 states","internal_default":2},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"TGOV1 has 2 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Steam Turbine-Governor. This model considers both TGOV1 or TGOV1DU in PSS/E.","struct_name":"SteamTurbineGov1","supertype":"TurbineGov"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Permanent droop parameter","valid_range":{"max":0.1,"min":0}},{"name":"r","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Temporary Droop","valid_range":{"max":2,"min":0}},{"name":"Tr","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Governor time constant","valid_range":{"max":30,"min":"eps()"}},{"valid_range":{"max":0.1,"min":"eps()"},"name":"Tf","data_type":"Float64","null_value":0,"valiation_action":"error","comment":"Filter Time constant"},{"name":"Tg","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Servo time constant","valid_range":{"max":1,"min":"eps()"}},{"name":"VELM","data_type":"Float64","null_value":0,"validation_action":"error","comment":"gate velocity limit","valid_range":{"max":0.3,"min":"eps()"}},{"name":"gate_position_limits","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Gate position limits"},{"name":"Tw","data_type":"Float64","null_value":0,"validation_action":"error","comment":"water time constant","valid_range":{"max":3,"min":"eps()"}},{"name":"At","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Turbine gain","valid_range":{"max":1.5,"min":0.8}},{"name":"D_T","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Turbine Damping","valid_range":{"max":0.5,"min":0}},{"name":"q_nl","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"No-power flow","valid_range":{"max":null,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the HydroTurbineGov model are:\n\tx_g1: filter_output,\n\tx_g2: desired gate, \n\tx_g3: gate opening, \n\tx_g4: turbine flow","internal_default":"[:x_g1, :x_g2, :x_g3, :x_g4]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"HYGOV has 4 states","internal_default":4},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"HYGOV has 4 differential states","internal_default":"[StateTypes.Differential, StateTypes.Differential, StateTypes.Differential, StateTypes.Differential]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Hydro Turbine-Governor.","struct_name":"HydroTurbineGov","supertype":"TurbineGov"},{"fields":[{"name":"K","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Governor Gain","valid_range":{"max":30,"min":5}},{"name":"T1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Input Filter Lag","valid_range":{"max":5,"min":0}},{"name":"T2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Input Filter Lead","valid_range":{"max":10,"min":0}},{"name":"T3","data_type":"Float64","null_value":0,"validation_action":"error","comment":"Valve position Time Constant","valid_range":{"max":1,"min":"eps()"}},{"name":"U0","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Maximum Valve Opening Rate","valid_range":{"max":0.03,"min":0.01}},{"name":"U_c","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Maximum Valve closing rate","valid_range":{"max":0,"min":-0.3}},{"name":"valve_position_limits","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Valve position limits in MW"},{"name":"T4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time Constant inlet steam","valid_range":{"max":1,"min":0}},{"name":"K1","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Fraction of high presure shaft power","valid_range":{"max":1,"min":-2}},{"name":"K2","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Fraction of low presure shaft power","valid_range":{"max":null,"min":0}},{"name":"T5","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for second boiler pass","valid_range":{"max":10,"min":0}},{"name":"K3","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Fraction of high presure shaft power second boiler pass","valid_range":{"max":0.5,"min":0}},{"name":"K4","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Fraction of low presure shaft power second boiler pass","valid_range":{"max":0.5,"min":0}},{"name":"T6","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for third boiler pass","valid_range":{"max":10,"min":0}},{"name":"K5","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Fraction of high presure shaft power third boiler pass","valid_range":{"max":0.35,"min":0}},{"name":"K6","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Fraction of low presure shaft power third boiler pass","valid_range":{"max":0.55,"min":0}},{"name":"T7","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Time constant for fourth boiler pass","valid_range":{"max":10,"min":0}},{"name":"K7","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Fraction of high presure shaft power fourth boiler pass","valid_range":{"max":0.3,"min":0}},{"name":"K8","data_type":"Float64","null_value":0,"validation_action":"warn","comment":"Fraction of low presure shaft power fourth boiler pass","valid_range":{"max":0.3,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the IEEETurbineGov model are:\n\tx_g1: First Governor integrator,\n\tx_g2: Governor output,\n\tx_g3: First Turbine integrator, \n\tx_g4: Second Turbine Integrator, \n\tx_g5: Third Turbine Integrator, \n\tx_g6: Fourth Turbine Integrator, ","internal_default":"[:x_g1, :x_g2, :x_g3, :x_g4, :x_g5, :x_g6]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"IEEEG1 has 6 states","internal_default":6},{"name":"states_types","data_type":"Vector{StateTypes}","comment":"IEEEG1 has 6 differential states","internal_default":"[StateTypes.Differential, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid, StateTypes.Hybrid]"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"IEEE Type 1 Speed-Governing Model","struct_name":"IEEETurbineGov1","supertype":"TurbineGov"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Droop parameter","valid_range":{"max":null,"min":0}},{"name":"Ts","data_type":"Float64","null_value":0,"comment":"Governor time constant","valid_range":{"max":null,"min":0}},{"name":"Tc","data_type":"Float64","null_value":0,"comment":"Servo time constant","valid_range":{"max":null,"min":0}},{"name":"T3","data_type":"Float64","null_value":0,"comment":"Transient gain time constant","valid_range":{"max":null,"min":0}},{"name":"T4","data_type":"Float64","null_value":0,"comment":"Power fraction time constant","valid_range":{"max":null,"min":0}},{"name":"T5","data_type":"Float64","null_value":0,"comment":"Reheat time constant","valid_range":{"max":null,"min":0}},{"name":"valve_position_limits","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Valve position limits in MW"},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the TGTypeI model are:\n\tx_g1: Governor state,\n\tx_g2: Servo state,\n\tx_g3: Reheat state","internal_default":"[:x_g1, :x_g2, :x_g3]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"TGTypeI has 3 states","internal_default":3},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of a Turbine Governor Type I.","struct_name":"TGTypeI","supertype":"TurbineGov"},{"fields":[{"name":"R","data_type":"Float64","null_value":0,"comment":"Droop parameter","valid_range":{"max":null,"min":0}},{"name":"T1","data_type":"Float64","null_value":0,"comment":"Transient gain time constant","valid_range":{"max":null,"min":0}},{"name":"T2","data_type":"Float64","null_value":0,"comment":"Power fraction time constant","valid_range":{"max":null,"min":0}},{"name":"τ_limits","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Power into the governor limits"},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the TGTypeI model are:\n\tx_g1: lead-lag state","internal_default":"[:xg]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"TGTypeII has 1 state","internal_default":1},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of a Turbine Governor Type II.","struct_name":"TGTypeII","supertype":"TurbineGov"},{"fields":[{"name":"rated_voltage","data_type":"Float64","null_value":0,"comment":"rated voltage","valid_range":{"max":null,"min":0}},{"name":"rated_current","data_type":"Float64","null_value":0,"comment":"rated VA","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"","internal_default":"Vector{Symbol}()"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"AverageConverter has no states","internal_default":0}],"docstring":"Parameters of an average converter model","struct_name":"AverageConverter","supertype":"Converter"},{"fields":[{"name":"T_g","data_type":"Float64","null_value":0,"comment":"Converter time constant (s)","valid_range":{"max":null,"min":0}},{"name":"Rrpwr","data_type":"Float64","null_value":0,"comment":"Low Voltage Power Logic (LVPL) ramp rate limit (pu/s)","valid_range":{"max":null,"min":0}},{"name":"Brkpt","data_type":"Float64","null_value":0,"comment":"LVPL characteristic voltage 2 (pu)","valid_range":{"max":null,"min":0}},{"name":"Zerox","data_type":"Float64","null_value":0,"comment":"LVPL characteristic voltage 1 (pu)","valid_range":{"max":null,"min":0}},{"name":"Lvpl1","data_type":"Float64","null_value":0,"comment":"LVPL gain (pu)","valid_range":{"max":null,"min":0}},{"name":"Vo_lim","data_type":"Float64","null_value":0,"comment":"Voltage limit for high voltage reactive current management (pu)","valid_range":{"max":null,"min":0}},{"name":"Lv_pnts","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Voltage points for low voltage active current management (pu) (Lvpnt0, Lvpnt1)"},{"name":"Io_lim","data_type":"Float64","null_value":0,"comment":"Current limit (pu) for high voltage reactive current management (specified as a negative value)","valid_range":{"max":0,"min":null}},{"name":"T_fltr","data_type":"Float64","null_value":0,"comment":"Voltage filter time constant for low voltage active current management (s)","valid_range":{"max":null,"min":0}},{"name":"K_hv","data_type":"Float64","null_value":0,"comment":"Overvoltage compensation gain used in the high voltage reactive current management","valid_range":{"max":null,"min":0}},{"name":"Iqr_lims","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limit on rate of change for reactive current (pu/s) (Iqr_min, Iqr_max)"},{"name":"Accel","data_type":"Float64","null_value":0,"comment":"Acceleration factor","valid_range":{"max":1,"min":0}},{"name":"Lvpl_sw","data_type":"Int","null_value":0,"comment":"Low voltage power logic (LVPL) switch. (0: LVPL not present, 1: LVPL present)","valid_range":{"max":1,"min":0}},{"name":"Q_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Initial machine reactive power from power flow","valid_range":{"max":null,"min":0}},{"name":"R_source","default":"0.0","data_type":"Float64","null_value":0,"comment":"Output resistor used for the Thevenin Equivalent","valid_range":{"max":null,"min":0}},{"name":"X_source","default":"1.0e5","data_type":"Float64","null_value":0,"comment":"Output resistor used for the Thevenin Equivalent","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\tIp: Converter lag for Ipcmd,\tIq: Converter lag for Iqcmd,\tVmeas: Voltage filter for low voltage active current management","internal_default":"[:Ip, :Iq, :Vmeas]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"RenewableEnergyConverterTypeA has 3 states","internal_default":3}],"docstring":"Parameters of a renewable energy generator/converter model, this model corresponds to REGCA1 in PSSE","struct_name":"RenewableEnergyConverterTypeA","supertype":"Converter"},{"fields":[{"name":"T_g","data_type":"Float64","null_value":0,"comment":"Converter time constant (s)","valid_range":{"max":null,"min":0}},{"name":"Rrpwr","data_type":"Float64","null_value":0,"comment":"Low Voltage Power Logic (LVPL) ramp rate limit (pu/s)","valid_range":{"max":null,"min":0}},{"name":"Brkpt","data_type":"Float64","null_value":0,"comment":"LVPL characteristic voltage 2 (pu)","valid_range":{"max":null,"min":0}},{"name":"Zerox","data_type":"Float64","null_value":0,"comment":"LVPL characteristic voltage 1 (pu)","valid_range":{"max":null,"min":0}},{"name":"Lvpl1","data_type":"Float64","null_value":0,"comment":"LVPL gain (pu)","valid_range":{"max":null,"min":0}},{"name":"Vo_lim","data_type":"Float64","null_value":0,"comment":"Voltage limit for high voltage reactive current management (pu)","valid_range":{"max":null,"min":0}},{"name":"Lv_pnts","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Voltage points for low voltage active current management (pu) (Lvpnt0, Lvpnt1)"},{"name":"Io_lim","data_type":"Float64","null_value":0,"comment":"Current limit (pu) for high voltage reactive current management (specified as a negative value)","valid_range":{"max":0,"min":null}},{"name":"T_fltr","data_type":"Float64","null_value":0,"comment":"Voltage filter time constant for low voltage active current management (s)","valid_range":{"max":null,"min":0}},{"name":"K_hv","data_type":"Float64","null_value":0,"comment":"Overvoltage compensation gain used in the high voltage reactive current management","valid_range":{"max":null,"min":0}},{"name":"Iqr_lims","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limit on rate of change for reactive current (pu/s) (Iqr_min, Iqr_max)"},{"name":"Accel","data_type":"Float64","null_value":0,"comment":"Acceleration factor","valid_range":{"max":1,"min":0}},{"name":"Lvpl_sw","data_type":"Int","null_value":0,"comment":"Low voltage power logic (LVPL) switch. (0: LVPL not present, 1: LVPL present)","valid_range":{"max":1,"min":0}},{"name":"Q_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Initial machine reactive power from power flow","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states are:\tIp: Converter lag for Ipcmd,\tIq: Converter lag for Iqcmd,\tVmeas: Voltage filter for low voltage active current management","internal_default":"[:Ip, :Iq, :Vmeas]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"RenewableEnergyVoltageConverterTypeA has 3 states","internal_default":3}],"docstring":"Parameters of a renewable energy generator/converter model, this model corresponds to REGCA1 in PSSE, but to be interfaced using a Voltage Source instead of a Current Source.","struct_name":"RenewableEnergyVoltageConverterTypeA","supertype":"Converter"},{"fields":[{"name":"voltage","data_type":"Float64","null_value":0,"comment":"rated VA","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"","internal_default":"Vector{Symbol}()"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"FixedDCSource has no states","internal_default":0},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of a Fixed DC Source that returns a fixed DC voltage","struct_name":"FixedDCSource","supertype":"DCSource"},{"fields":[{"name":"rated_voltage","data_type":"Float64","null_value":0,"comment":"rated voltage","valid_range":{"max":null,"min":0}},{"name":"rated_current","data_type":"Float64","null_value":0,"comment":"rated current","valid_range":{"max":null,"min":0}},{"name":"battery_voltage","data_type":"Float64","null_value":0,"comment":"battery voltage","valid_range":{"max":null,"min":0}},{"name":"battery_resistance","data_type":"Float64","null_value":0,"comment":"battery_resistance","valid_range":{"max":null,"min":0}},{"name":"dc_dc_inductor","data_type":"Float64","null_value":0,"comment":"DC/DC inductance","valid_range":{"max":null,"min":0}},{"name":"dc_link_capacitance","data_type":"Float64","null_value":0,"comment":"DC-link capacitor","valid_range":{"max":null,"min":0}},{"name":"fs","data_type":"Float64","null_value":0,"comment":"DC/DC converter switching frequency","valid_range":{"max":null,"min":0}},{"name":"kpv","data_type":"Float64","null_value":0,"comment":"voltage controller proportional gain","valid_range":{"max":null,"min":0}},{"name":"kiv","data_type":"Float64","null_value":0,"comment":"voltage controller integral gain","valid_range":{"max":null,"min":0}},{"name":"kpi","data_type":"Float64","null_value":0,"comment":"current controller proportional gain","valid_range":{"max":null,"min":0}},{"name":"kii","data_type":"Float64","null_value":0,"comment":"current controller integral gain","valid_range":{"max":null,"min":0}},{"name":"Vdc_ref","default":"1.1","data_type":"Float64","null_value":0,"comment":"Reference DC-Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the ZeroOrderBESS model are:\n\tv_dc: DC-link votlage,\n\ti_b: Battery current,\n\t ν: integrator state of the voltage controller,\n\t ζ: integrator state of the PI current controller","internal_default":"[:v_dc, :i_b, :ν, :ζ]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ZeroOrderBESS has 4 states","internal_default":4}],"docstring":"Parameters for the DC-side with a Battery Energy Storage System from paper at https://arxiv.org/abs/2007.11776","struct_name":"ZeroOrderBESS","supertype":"DCSource"},{"fields":[{"name":"lf","data_type":"Float64","null_value":0,"comment":"Series inductance in p.u. of converter filter","valid_range":{"max":null,"min":0}},{"name":"rf","data_type":"Float64","null_value":0,"comment":"Series resistance in p.u. of converter filter","valid_range":{"max":null,"min":0}},{"name":"cf","data_type":"Float64","null_value":0,"comment":"Shunt capacitance in p.u. of converter filter","valid_range":{"max":null,"min":0}},{"name":"lg","data_type":"Float64","null_value":0,"comment":"Series inductance in p.u. of converter filter to the grid","valid_range":{"max":null,"min":0}},{"name":"rg","data_type":"Float64","null_value":0,"comment":"Series resistance in p.u. of converter filter to the grid","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the LCLFilter model are:\n\tir_cnv: Real current out of the converter,\n\tii_cnv: Imaginary current out of the converter,\n\tvr_filter: Real voltage at the filter's capacitor,\n\tvi_filter: Imaginary voltage at the filter's capacitor,\n\tir_filter: Real current out of the filter,\n\tii_filter: Imaginary current out of the filter","internal_default":"[:ir_cnv, :ii_cnv, :vr_filter, :vi_filter, :ir_filter, :ii_filter]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"LCLFilter has 6 states","internal_default":6}],"docstring":"Parameters of a LCL filter outside the converter, the states are in the grid's reference frame","struct_name":"LCLFilter","supertype":"Filter"},{"fields":[{"name":"lf","data_type":"Float64","null_value":0,"comment":"filter inductance","valid_range":{"max":null,"min":0}},{"name":"rf","data_type":"Float64","null_value":0,"comment":"filter resistance","valid_range":{"max":null,"min":0}},{"name":"cf","data_type":"Float64","null_value":0,"comment":"filter capacitance","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the LCFilter model are:\n\tir_filter: Real current out of the filter,\n\tii_filter: Imaginary current out of the filter","internal_default":"[:ir_filter, :ii_filter]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"LCFilter has two states","internal_default":2}],"docstring":"Parameters of a LCL filter outside the converter","struct_name":"LCFilter","supertype":"Filter"},{"fields":[{"name":"rf","data_type":"Float64","null_value":0,"comment":"Series resistance in p.u. of converter filter to the grid","valid_range":{"max":null,"min":0}},{"name":"lf","data_type":"Float64","null_value":0,"comment":"Series inductance in p.u. of converter filter to the grid","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"RLFilter has zero states","internal_default":"Vector{Symbol}()"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"RLFilter has zero states","internal_default":0}],"docstring":"Parameters of RL series filter in algebraic representation","struct_name":"RLFilter","supertype":"Filter"},{"fields":[{"name":"ω_lp","data_type":"Float64","null_value":0,"comment":"PLL low-pass filter frequency (rad/sec)","valid_range":{"max":null,"min":0}},{"name":"kp_pll","data_type":"Float64","null_value":0,"comment":"PLL proportional gain","valid_range":{"max":null,"min":0}},{"name":"ki_pll","data_type":"Float64","null_value":0,"comment":"PLL integral gain","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the KauraPLL model are:\n\tvd_pll: d-axis of the measured voltage in the PLL synchronous reference frame (SRF),\n\tvq_pll: q-axis of the measured voltage in the PLL SRF,\n\tε_pll: Integrator state of the PI controller,\n\tθ_pll: Phase angle displacement in the PLL SRF","internal_default":"[:vd_pll, :vq_pll, :ε_pll, :θ_pll]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"KauraPLL has 4 states","internal_default":4}],"docstring":"Parameters of a Phase-Locked Loop (PLL) based on Kaura, Vikram, and Vladimir Blasko.\n\"Operation of a phase locked loop system under distorted utility conditions.\"\nIEEE Transactions on Industry applications 33.1 (1997): 58-63.","struct_name":"KauraPLL","supertype":"FrequencyEstimator"},{"fields":[{"name":"ω_lp","data_type":"Float64","null_value":0,"comment":"PLL low-pass filter frequency (rad/sec)","valid_range":{"max":null,"min":0}},{"name":"kp_pll","data_type":"Float64","null_value":0,"comment":"PLL proportional gain","valid_range":{"max":null,"min":0}},{"name":"ki_pll","data_type":"Float64","null_value":0,"comment":"PLL integral gain","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the ReducedOrderPLL model are:\n\tvq_pll: q-axis of the measured voltage in the PLL synchronous reference frame (SRF),\n\tε_pll: Integrator state of the PI controller,\n\tθ_pll: Phase angle displacement in the PLL SRF","internal_default":"[:vq_pll, :ε_pll, :θ_pll]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ReducedOrderPLL has 3 states","internal_default":3}],"docstring":"Parameters of a Phase-Locked Loop (PLL) based on Purba, Dhople, Jafarpour, Bullo and Johnson.\n\"Reduced-order Structure-preserving Model for Parallel-connected Three-phase Grid-tied Inverters.\"\n2017 IEEE 18th Workshop on Control and Modeling for Power Electronics (COMPEL): 1-7.","struct_name":"ReducedOrderPLL","supertype":"FrequencyEstimator"},{"fields":[{"name":"frequency","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference used"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"FixedFrequency has no states","internal_default":"Vector{Symbol}()"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"FixedFrequency has no states","internal_default":0}],"docstring":"Parameters of a Fixed Frequency Estimator (i.e. no PLL).","struct_name":"FixedFrequency","supertype":"FrequencyEstimator"},{"fields":[{"name":"Ta","data_type":"Float64","null_value":0,"comment":"VSM inertia constant","valid_range":{"max":null,"min":0}},{"name":"kd","data_type":"Float64","null_value":0,"comment":"VSM damping constant","valid_range":{"max":null,"min":0}},{"name":"kω","data_type":"Float64","null_value":0,"comment":"frequency droop gain","valid_range":{"max":null,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the VirtualInertia model are:\n\tθ_oc: Phase angle displacement of the virtual synchronous generator model\n\tω_oc: Speed of the rotating reference frame of the virtual synchronous generator model","internal_default":"[:θ_oc, :ω_oc]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"VirtualInertia has two states","internal_default":2}],"docstring":"Parameters of a Virtual Inertia with SRF using VSM for active power controller","struct_name":"VirtualInertia","supertype":"ActivePowerControl"},{"fields":[{"name":"Rp","data_type":"Float64","null_value":0,"comment":"Droop Gain","valid_range":{"max":null,"min":0}},{"name":"ωz","data_type":"Float64","null_value":0,"comment":"filter frequency cutoff","valid_range":{"max":null,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the ActivePowerDroop model are:\n\tθ_oc: Phase angle displacement of the inverter model,\n\tp_oc: Measured active power of the inverter model","internal_default":"[:θ_oc, :p_oc]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ActivePowerDroop has two states","internal_default":2}],"docstring":"Parameters of an Active Power droop controller","struct_name":"ActivePowerDroop","supertype":"ActivePowerControl"},{"fields":[{"name":"Kp_p","data_type":"Float64","null_value":0,"comment":"Proportional Gain","valid_range":{"max":null,"min":0}},{"name":"Ki_p","data_type":"Float64","null_value":0,"comment":"Integral Gain","valid_range":{"max":null,"min":0}},{"name":"ωz","data_type":"Float64","null_value":0,"comment":"filter frequency cutoff","valid_range":{"max":null,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the ActivePowerPI model are:\n\tσp_oc: Integrator state of the PI Controller,\n\tp_oc: Measured active power of the inverter model","internal_default":"[:σp_oc, :p_oc]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ActivePowerPI has two states","internal_default":2}],"docstring":"Parameters of a Proportional-Integral Active Power controller for a specified power reference","struct_name":"ActivePowerPI","supertype":"ActivePowerControl"},{"fields":[{"name":"k1","data_type":"Float64","null_value":0,"comment":"VOC Synchronization Gain","valid_range":{"max":null,"min":0}},{"name":"ψ","data_type":"Float64","null_value":0,"comment":"Rotation angle of the controller","valid_range":{"max":null,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the ActiveVirtualOscillator model are:\n\tθ_oc: Phase angle displacement of the inverter model","internal_default":"[:θ_oc]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ActiveVirtualOscillator has one state","internal_default":1}],"docstring":"Parameters of an Active Virtual Oscillator controller. Model is based from the paper Model Reduction for Inverters with Current Limiting and Dispatchable Virtual Oscillator Control by O. Ajala et al.","struct_name":"ActiveVirtualOscillator","supertype":"ActivePowerControl"},{"fields":[{"name":"bus_control","data_type":"Int","null_value":0,"comment":"Bus Number for voltage control; ","valid_range":{"max":null,"min":0}},{"name":"from_branch_control","data_type":"Int","null_value":0,"comment":"Monitored branch FROM bus number for line drop compensation (if 0 generator power will be used)","valid_range":{"max":null,"min":0}},{"name":"to_branch_control","data_type":"Int","null_value":0,"comment":"Monitored branch TO bus number for line drop compensation (if 0 generator power will be used)","valid_range":{"max":null,"min":0}},{"name":"branch_id_control","data_type":"String","null_value":0,"comment":"Branch circuit id for line drop compensation (as a string). If 0 generator power will be used"},{"name":"Freq_Flag","data_type":"Int","null_value":0,"comment":"Frequency Flag for REPCA1: 0: disable, 1:enable","valid_range":{"max":1,"min":0}},{"name":"K_pg","data_type":"Float64","null_value":0,"comment":"Active power PI control proportional gain","valid_range":{"max":null,"min":0}},{"name":"K_ig","data_type":"Float64","null_value":0,"comment":"Active power PI control integral gain","valid_range":{"max":null,"min":0}},{"name":"T_p","data_type":"Float64","null_value":0,"comment":"Real power measurement filter time constant (s)","valid_range":{"max":null,"min":0}},{"name":"fdbd_pnts","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Frequency error dead band thresholds `(fdbd1, fdbd2)`"},{"name":"fe_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Upper/Lower limit on frequency error `(fe_min, fe_max)`"},{"name":"P_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Upper/Lower limit on power reference `(P_min, P_max)`"},{"name":"T_g","data_type":"Float64","null_value":0,"comment":"Power Controller lag time constant","valid_range":{"max":null,"min":0}},{"name":"D_dn","data_type":"Float64","null_value":0,"comment":"Droop for over-frequency conditions","valid_range":{"max":0,"min":null}},{"name":"D_up","data_type":"Float64","null_value":0,"comment":"Droop for under-frequency conditions","valid_range":{"max":null,"min":0}},{"name":"dP_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Upper/Lower limit on power reference ramp rates`(dP_min, dP_max)`"},{"name":"P_lim_inner","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Upper/Lower limit on power reference for REECB`(P_min_inner, P_max_inner)`"},{"name":"T_pord","data_type":"Float64","null_value":0,"comment":"Power filter time constant REECB time constant","valid_range":{"max":null,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the ActiveRenewableControllerAB model depends on the Flag","internal_default":"PowerSystems.get_activeRETypeAB_states(Freq_Flag)[1]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The states of the ActiveRenewableControllerAB model depends on the Flag","internal_default":"PowerSystems.get_activeRETypeAB_states(Freq_Flag)[2]"}],"docstring":"Parameters of Active Power Controller including REPCA1 and REECB1","struct_name":"ActiveRenewableControllerAB","supertype":"ActivePowerControl"},{"fields":[{"name":"bus_control","data_type":"Int","null_value":0,"comment":"Bus Number for voltage control; ","valid_range":{"max":null,"min":0}},{"name":"from_branch_control","data_type":"Int","null_value":0,"comment":"Monitored branch FROM bus number for line drop compensation (if 0 generator power will be used)","valid_range":{"max":null,"min":0}},{"name":"to_branch_control","data_type":"Int","null_value":0,"comment":"Monitored branch TO bus number for line drop compensation (if 0 generator power will be used)","valid_range":{"max":null,"min":0}},{"name":"branch_id_control","data_type":"String","null_value":0,"comment":"Branch circuit id for line drop compensation (as a string). If 0 generator power will be used"},{"name":"VC_Flag","data_type":"Int","null_value":0,"comment":"Voltage Compensator Flag for REPCA1","valid_range":{"max":1,"min":0}},{"name":"Ref_Flag","data_type":"Int","null_value":0,"comment":"Flag for Reactive Power Control for REPCA1. 0: Q-control, 1: V-control","valid_range":{"max":1,"min":0}},{"name":"PF_Flag","data_type":"Int","null_value":0,"comment":"Flag for Power Factor Control for Outer Control of REECB1. 0: Q-control, 1: Power Factor Control","valid_range":{"max":1,"min":0}},{"name":"V_Flag","data_type":"Int","null_value":0,"comment":"Flag for Voltage Control for Outer Control of REECB1. 0: Voltage Control, 1: Q-Control","valid_range":{"max":1,"min":0}},{"name":"T_fltr","data_type":"Float64","null_value":0,"comment":"Voltage or Q-power of REPCA Filter Time Constant","valid_range":{"max":null,"min":0}},{"name":"K_p","data_type":"Float64","null_value":0,"comment":"Reactive power PI control proportional gain","valid_range":{"max":null,"min":0}},{"name":"K_i","data_type":"Float64","null_value":0,"comment":"Reactive power PI control integral gain","valid_range":{"max":null,"min":0}},{"name":"T_ft","data_type":"Float64","null_value":0,"comment":"Reactive power lead time constant (s)","valid_range":{"max":null,"min":0}},{"name":"T_fv","data_type":"Float64","null_value":0,"comment":"Reactive power lag time constant (s)","valid_range":{"max":null,"min":0}},{"name":"V_frz","data_type":"Float64","null_value":0,"comment":"Voltage below which state ξq_oc (integrator state) is freeze","valid_range":{"max":null,"min":0}},{"name":"R_c","data_type":"Float64","null_value":0,"comment":"Line drop compensation resistance (used when VC_Flag = 1)","valid_range":{"max":null,"min":0}},{"name":"X_c","data_type":"Float64","null_value":0,"comment":"Line drop compensation reactance (used when VC_Flag = 1)","valid_range":{"max":null,"min":0}},{"name":"K_c","data_type":"Float64","null_value":0,"comment":"Reactive current compensation gain (pu) (used when VC_Flag = 0)","valid_range":{"max":null,"min":0}},{"name":"e_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Upper/Lower limit on Voltage or Q-power deadband output `(e_min, e_max)`"},{"name":"dbd_pnts","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Voltage or Q-power error dead band thresholds `(dbd1, dbd2)`"},{"name":"Q_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Upper/Lower limit on reactive power V/Q control in REPCA `(Q_min, Q_max)`"},{"name":"T_p","data_type":"Float64","null_value":0,"comment":"Active power lag time constant in REECB (s). Used only when PF_Flag = 1","valid_range":{"max":null,"min":0}},{"name":"Q_lim_inner","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Upper/Lower limit on reactive power input in REECB `(Q_min_inner, Q_max_inner)`. Only used when V_Flag = 1"},{"name":"V_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Upper/Lower limit on reactive power PI controller in REECB `(V_min, V_max)`. Only used when V_Flag = 1"},{"name":"K_qp","data_type":"Float64","null_value":0,"comment":"Reactive power regulator proportional gain (used when V_Flag = 1)","valid_range":{"max":null,"min":0}},{"name":"K_qi","data_type":"Float64","null_value":0,"comment":"Reactive power regulator integral gain (used when V_Flag = 1)","valid_range":{"max":null,"min":0}},{"name":"Q_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Power Set-point","valid_range":{"max":null,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the ReactiveRenewableControllerAB model depends on the Flag","internal_default":"PowerSystems.get_reactiveRETypeAB_states(Ref_Flag, PF_Flag, V_Flag)[1]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The states of the ReactiveRenewableControllerAB model depends on the Flag","internal_default":"PowerSystems.get_reactiveRETypeAB_states(Ref_Flag, PF_Flag, V_Flag)[2]"}],"docstring":"Parameters of Reactive Power Controller including REPCA1 and REECB1","struct_name":"ReactiveRenewableControllerAB","supertype":"ReactivePowerControl"},{"fields":[{"name":"kq","data_type":"Float64","null_value":0,"comment":"frequency droop gain","valid_range":{"max":null,"min":0}},{"name":"ωf","data_type":"Float64","null_value":0,"comment":"filter frequency cutoff","valid_range":{"max":null,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the ReactivePowerDroop model are:\n\tq_oc: Filtered reactive output power","internal_default":"[:q_oc]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ReactivePowerDroop has 1 state","internal_default":1}],"docstring":"Parameters of a Reactive Power droop controller","struct_name":"ReactivePowerDroop","supertype":"ReactivePowerControl"},{"fields":[{"name":"Kp_q","data_type":"Float64","null_value":0,"comment":"Proportional Gain","valid_range":{"max":null,"min":0}},{"name":"Ki_q","data_type":"Float64","null_value":0,"comment":"Integral Gain","valid_range":{"max":null,"min":0}},{"name":"ωf","data_type":"Float64","null_value":0,"comment":"filter frequency cutoff","valid_range":{"max":null,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"Q_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reactive Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the ReactivePowerPI model are:\n\tσq_oc: Integrator state of the PI Controller,\n\tq_oc: Measured reactive power of the inverter model","internal_default":"[:σq_oc, :q_oc]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ReactivePowerPI has two states","internal_default":2}],"docstring":"Parameters of a Proportional-Integral Reactive Power controller for a specified power reference","struct_name":"ReactivePowerPI","supertype":"ReactivePowerControl"},{"fields":[{"name":"k2","data_type":"Float64","null_value":0,"comment":"VOC voltage-amplitude control gain","valid_range":{"max":null,"min":0}},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Voltage Set-point","valid_range":{"max":null,"min":0}},{"name":"Q_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference Reactive Power Set-point","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the ReactiveVirtualOscilator model are:\n\tE_oc: voltage reference state for inner control in the d-axis","internal_default":"[:E_oc]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"ReactiveVirtualOscillator has 1 state","internal_default":1}],"docstring":"Parameters of a Reactive Virtual Oscillator controller. Model is based from the paper Model Reduction for Inverters with Current Limiting and Dispatchable Virtual Oscillator Control by O. Ajala et al.","struct_name":"ReactiveVirtualOscillator","supertype":"ReactivePowerControl"},{"fields":[{"name":"kpv","data_type":"Float64","null_value":0,"comment":"voltage controller proportional gain","valid_range":{"max":null,"min":0}},{"name":"kiv","data_type":"Float64","null_value":0,"comment":"voltage controller integral gain","valid_range":{"max":null,"min":0}},{"name":"kffv","data_type":"Float64","null_value":0,"comment":"Binary variable to enable feed-forward gain of voltage.","valid_range":{"max":null,"min":0}},{"name":"rv","data_type":"Float64","null_value":0,"comment":"virtual resistance","valid_range":{"max":null,"min":0}},{"name":"lv","data_type":"Float64","null_value":0,"comment":"virtual inductance","valid_range":{"max":null,"min":0}},{"name":"kpc","data_type":"Float64","null_value":0,"comment":"current controller proportional gain","valid_range":{"max":null,"min":0}},{"name":"kic","data_type":"Float64","null_value":0,"comment":"current controller integral gain","valid_range":{"max":null,"min":0}},{"name":"kffi","data_type":"Float64","null_value":0,"comment":"Binary variable to enable feed-forward gain of current","valid_range":{"max":null,"min":0}},{"name":"ωad","data_type":"Float64","null_value":0,"comment":"active damping filter cutoff frequency (rad/sec)","valid_range":{"max":null,"min":0}},{"name":"kad","data_type":"Float64","null_value":0,"comment":"active damping gain","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the VoltageModeControl model are:\n\tξd_ic: d-axis integrator state of the PI voltage controller,\n\tξq_ic: q-axis integrator state of the PI voltage controller,\n\tγd_ic: d-axis integrator state of the PI current controller,\n\tγq_ic: q-axis integrator state of the PI current controller,\n\tϕd_ic: d-axis low-pass filter of active damping,\n\tϕq_ic: q-axis low-pass filter of active damping","internal_default":"[:ξd_ic, :ξq_ic, :γd_ic, :γq_ic, :ϕd_ic, :ϕq_ic]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"VoltageModeControl has 6 states","internal_default":6}],"docstring":"Parameters of an inner loop current control PID using virtual impedance based on D'Arco, Suul and Fosso.\n\"A Virtual Synchronous Machine implementation for distributed control of power converters in SmartGrids.\"\nElectric Power Systems Research 122 (2015) 180–197.","struct_name":"VoltageModeControl","supertype":"InnerControl"},{"fields":[{"name":"kpc","data_type":"Float64","null_value":0,"comment":"Current controller proportional gain","valid_range":{"max":null,"min":0}},{"name":"kic","data_type":"Float64","null_value":0,"comment":"Current controller integral gain","valid_range":{"max":null,"min":0}},{"name":"kffv","data_type":"Float64","null_value":0,"comment":"Gain to enable feed-forward gain of voltage.","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the CurrentModeControl model are:\n\tγd_ic: d-axis integrator state of the PI current controller,\n\tγq_ic: q-axis integrator state of the PI current controller","internal_default":"[:γd_ic, :γq_ic]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"CurrentControl has 2 states","internal_default":2}],"docstring":"Parameters of an inner loop PI current control using based on Purba, Dhople, Jafarpour, Bullo and Johnson.\n\"Reduced-order Structure-preserving Model for Parallel-connected Three-phase Grid-tied Inverters.\"\n2017 IEEE 18th Workshop on Control and Modeling for Power Electronics (COMPEL): 1-7.","struct_name":"CurrentModeControl","supertype":"InnerControl"},{"fields":[{"name":"Q_Flag","data_type":"Int","null_value":0,"comment":"Q Flag used for I_qinj","valid_range":{"max":1,"min":0}},{"name":"PQ_Flag","data_type":"Int","null_value":0,"comment":"PQ Flag used for the Current Limit Logic","valid_range":{"max":1,"min":0}},{"name":"Vdip_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for Voltage Dip Logic `(Vdip, Vup)`"},{"name":"T_rv","data_type":"Float64","null_value":0,"comment":"Voltage Filter Time Constant","valid_range":{"max":null,"min":0}},{"name":"dbd_pnts","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Voltage error deadband thresholds `(dbd1, dbd2)`"},{"name":"K_qv","data_type":"Float64","null_value":0,"comment":"Reactive current injection gain during over and undervoltage conditions","valid_range":{"max":null,"min":0}},{"name":"Iqinj_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limits for Iqinj `(I_qh1, I_ql1)`"},{"name":"V_ref0","data_type":"Float64","null_value":0,"comment":"User defined reference. If 0, PSID initializes to initial terminal voltage","valid_range":{"max":null,"min":0}},{"name":"K_vp","data_type":"Float64","null_value":0,"comment":"Voltage regulator proportional gain (used when QFlag = 1)","valid_range":{"max":null,"min":0}},{"name":"K_vi","data_type":"Float64","null_value":0,"comment":"Voltage regulator integral gain (used when QFlag = 1)","valid_range":{"max":null,"min":0}},{"name":"T_iq","data_type":"Float64","null_value":0,"comment":"Time constant for low-pass filter for state q_V when QFlag = 0","valid_range":{"max":null,"min":0}},{"name":"I_max","data_type":"Float64","null_value":0,"comment":"Maximum limit on total converter current","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of the RECurrentControlB depends on the Flags","internal_default":"PowerSystems.get_REControlB_states(Q_Flag)"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The states of the RECurrentControlB depends on the Flags","internal_default":"2"}],"docstring":"Parameters of the Inner Control part of the REECB model in PSS/E","struct_name":"RECurrentControlB","supertype":"InnerControl"},{"fields":[{"name":"I_max","data_type":"Float64","null_value":0,"comment":"Maximum limit on current controller input current (device base)","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"}],"docstring":"Parameters of Magnitude (Circular) Current Controller Limiter","struct_name":"MagnitudeCurrentLimiter","supertype":"InverterLimiter"},{"fields":[{"name":"Id_max","data_type":"Float64","null_value":0,"comment":"Maximum limit on d-axis current controller input current (device base)","valid_range":{"max":null,"min":0}},{"name":"Iq_max","data_type":"Float64","null_value":0,"comment":"Maximum limit on d-axis current controller input current (device base)","valid_range":{"max":null,"min":0}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"}],"docstring":"Parameters of Instantaneous (Square) Current Controller Limiter","struct_name":"InstantaneousCurrentLimiter","supertype":"InverterLimiter"},{"fields":[{"name":"I_max","data_type":"Float64","null_value":0,"comment":"Maximum limit on current controller input current (device base)","valid_range":{"max":null,"min":0}},{"name":"ϕ_I","data_type":"Float64","null_value":0,"comment":"Pre-defined angle (measured against the d-axis) for Iref once limit is hit","valid_range":{"max":1.571,"min":-1.571}},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"}],"docstring":"Parameters of Priority-Based Current Controller Limiter","struct_name":"PriorityCurrentLimiter","supertype":"InverterLimiter"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"Pf_Flag","data_type":"Int","null_value":0,"comment":"Flag for Power Factor Control","valid_range":{"max":1,"min":0}},{"name":"Freq_Flag","data_type":"Int","null_value":0,"comment":"Flag to enable/disable frequency control","valid_range":{"max":1,"min":0}},{"name":"PQ_Flag","data_type":"Int","null_value":0,"comment":"Flag used to enforce maximum current","valid_range":{"max":1,"min":0}},{"name":"Gen_Flag","data_type":"Int","null_value":0,"comment":"Flag to specify generator or storage","valid_range":{"max":1,"min":0}},{"name":"Vtrip_Flag","data_type":"Int","null_value":0,"comment":"Flag to enable/disable voltage trip logic","valid_range":{"max":1,"min":0}},{"name":"Ftrip_Flag","data_type":"Int","null_value":0,"comment":"Flag to enable/disable frequency trip logic","valid_range":{"max":1,"min":0}},{"name":"T_rv","data_type":"Float64","null_value":0,"comment":"Voltage measurement transducer time constant","valid_range":{"max":null,"min":0}},{"name":"Trf","data_type":"Float64","null_value":0,"comment":"Frequency measurement transducer time constant","valid_range":{"max":null,"min":0}},{"name":"dbd_pnts","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Voltage deadband thresholds `(dbd1, dbd2)`"},{"name":"K_qv","data_type":"Float64","null_value":0,"comment":"Proportional voltage control gain (pu)","valid_range":{"max":null,"min":0}},{"name":"Tp","data_type":"Float64","null_value":0,"comment":"Power measurement transducer time constant","valid_range":{"max":null,"min":0}},{"name":"T_iq","data_type":"Float64","null_value":0,"comment":"Time constant for low-pass filter for state q_V when QFlag = 0","valid_range":{"max":null,"min":0}},{"name":"D_dn","data_type":"Float64","null_value":0,"comment":"Reciprocal of droop for over-frequency conditions (>0) (pu)","valid_range":{"max":null,"min":0}},{"name":"D_up","data_type":"Float64","null_value":0,"comment":"Reciprocal of droop for under-frequency conditions <=0) (pu)","valid_range":{"max":null,"min":0}},{"name":"fdbd_pnts","data_type":"Tuple{Float64, Float64}","null_value":"(0.0, 0.0)","comment":"Frequency control deadband thresholds `(fdbd1, fdbd2)`"},{"name":"fe_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Frequency error limits (femin, femax)"},{"name":"P_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Power limits (Pmin, Pmax)"},{"name":"dP_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Power reference ramp rate limits (dPmin, dPmax)"},{"name":"Tpord","data_type":"Float64","null_value":0,"comment":"Power filter time constant","valid_range":{"max":null,"min":0}},{"name":"Kpg","data_type":"Float64","null_value":0,"comment":"PI controller proportional gain (pu)","valid_range":{"max":null,"min":0}},{"name":"Kig","data_type":"Float64","null_value":0,"comment":"PI controller integral gain (pu)","valid_range":{"max":null,"min":0}},{"name":"I_max","data_type":"Float64","null_value":0,"comment":"Maximum limit on total converter current (pu)","valid_range":{"max":null,"min":0}},{"name":"vl_pnts","data_type":"Vector{Tuple{Float64,Float64}}","null_value":"[(0.0, 0.0), (0.0, 0.0)]","comment":"Low voltage cutout points `[(tv10, vl0), (tv11, vl1)]`"},{"name":"vh_pnts","data_type":"Vector{Tuple{Float64,Float64}}","null_value":"[(0.0, 0.0), (0.0, 0.0)]","comment":"High voltage cutout points `[(tvh0, vh0), (tvh1, vh1)]`"},{"name":"Vrfrac","data_type":"Float64","null_value":0,"comment":"Fraction of device that recovers after voltage comes back to within vl1 < V < vh1 (0 <= Vrfrac <= 1)","valid_range":{"max":1,"min":0}},{"name":"fl","data_type":"Float64","null_value":0,"comment":"Inverter frequency break-point for low frequency cut-out (Hz)","valid_range":{"max":null,"min":0}},{"name":"fh","data_type":"Float64","null_value":0,"comment":"Inverter frequency break-point for high frequency cut-out (Hz)","valid_range":{"max":null,"min":0}},{"name":"tfl","data_type":"Float64","null_value":0,"comment":"Low frequency cut-out timer corresponding to frequency fl (s)","valid_range":{"max":null,"min":0}},{"name":"tfh","data_type":"Float64","null_value":0,"comment":"High frequency cut-out timer corresponding to frequency fh (s)","valid_range":{"max":null,"min":0}},{"name":"Tg","data_type":"Float64","null_value":0,"comment":"Current control time constant (to represent behavior of inner control loops) (> 0) (s)","valid_range":{"max":null,"min":0}},{"name":"rrpwr","data_type":"Float64","null_value":0,"comment":"Ramp rate for real power increase following a fault (pu/s)","valid_range":{"max":null,"min":0}},{"name":"Tv","data_type":"Float64","null_value":0,"comment":"Time constant on the output of the multiplier (s)","valid_range":{"max":null,"min":0}},{"name":"Vpr","data_type":"Float64","null_value":0,"comment":"Voltage below which frequency tripping is disabled (pu)","valid_range":{"max":null,"min":0}},{"name":"Iq_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Reactive current injection limits (Iqll, Iqhl)"},{"name":"V_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"User defined voltage reference. If 0, PSID initializes to initial terminal voltage","valid_range":{"max":null,"min":0}},{"name":"Pfa_ref","default":"0.0","data_type":"Float64","null_value":0,"comment":"Reference power factor","valid_range":{"max":null,"min":0}},{"name":"ω_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference frequency","valid_range":{"max":null,"min":0}},{"name":"Q_ref","default":"0.0","data_type":"Float64","null_value":0,"comment":"Reference reactive power, in pu","valid_range":{"max":null,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference active power, in pu","valid_range":{"max":null,"min":0}},{"name":"base_power","default":"100.0","data_type":"Float64","null_value":0,"comment":"Base power"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of AggregateDistributedGenerationA depends on the Flags","internal_default":"PowerSystems.get_AggregateDistributedGenerationA_states(Freq_Flag)[1]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The states of AggregateDistributedGenerationA depends on the Flags","internal_default":"PowerSystems.get_AggregateDistributedGenerationA_states(Freq_Flag)[2]"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of the DERA1 model in PSS/E","struct_name":"AggregateDistributedGenerationA","supertype":"DynamicInjection"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"available","data_type":"Bool","null_value":"false"},{"name":"bus","data_type":"ACBus","null_value":"ACBus(nothing)"},{"name":"active_power","data_type":"Float64","null_value":"0.0"},{"name":"reactive_power","data_type":"Float64","null_value":"0.0"},{"name":"R_th","data_type":"Float64","null_value":0,"comment":"Source Thevenin resistance","valid_range":{"max":null,"min":0}},{"name":"X_th","data_type":"Float64","null_value":0,"comment":"Source Thevenin reactance","valid_range":{"max":null,"min":0}},{"name":"internal_voltage","default":"1.0","data_type":"Float64","null_value":0,"comment":"Internal Voltage","valid_range":{"max":null,"min":0}},{"name":"internal_angle","default":"0.0","data_type":"Float64","null_value":0,"comment":"Internal Angle"},{"name":"dynamic_injector","default":"nothing","data_type":"Union{Nothing, DynamicInjection}","exclude_setter":true,"null_value":"nothing","comment":"corresponding dynamic injection device"},{"name":"services","default":"Device[]","data_type":"Vector{Service}","null_value":"Device[]","comment":"Services that this device contributes to"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"This struct acts as an infinity bus.","struct_name":"Source","supertype":"StaticInjection"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"R_th","data_type":"Float64","null_value":0,"comment":"Source Thevenin resistance","valid_range":{"max":null,"min":0}},{"name":"X_th","data_type":"Float64","null_value":0,"comment":"Source Thevenin reactance","valid_range":{"max":null,"min":0}},{"name":"internal_voltage_bias","default":"0.0","data_type":"Float64","null_value":0,"comment":"a0 term of the Fourier Series for the voltage"},{"name":"internal_voltage_frequencies","default":"[0.0]","data_type":"Vector{Float64}","null_value":[0],"comment":"Frequencies in radians/s"},{"name":"internal_voltage_coefficients","default":"[(0.0, 0.0)]","data_type":"Vector{Tuple{Float64,Float64}}","null_value":"[(0.0, 0.0)]","comment":"Coefficients for terms n > 1. First component corresponds to sin and second component to cos"},{"name":"internal_angle_bias","default":"0.0","data_type":"Float64","null_value":0,"comment":"a0 term of the Fourier Series for the angle"},{"name":"internal_angle_frequencies","default":"[0.0]","data_type":"Vector{Float64}","null_value":[0],"comment":"Frequencies in radians/s"},{"name":"internal_angle_coefficients","default":"[(0.0, 0.0)]","data_type":"Vector{Tuple{Float64,Float64}}","null_value":"[(0.0, 0.0)]","comment":"Coefficients for terms n > 1. First component corresponds to sin and second component to cos"},{"name":"base_power","default":"100.0","data_type":"Float64","null_value":0,"comment":"Base power"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"State for time, voltage and angle","internal_default":"[:Vt, :θt]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"null_value":2,"internal_default":2},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"This struct acts as an infinity bus with time varying phasor values magnitude and angle V(t) \theta(t). Time varying functions are represented using fourier series","struct_name":"PeriodicVariableSource","supertype":"DynamicInjection"},{"fields":[{"name":"name","data_type":"String","exclude_setter":true,"null_value":"init"},{"name":"Qref_Flag","data_type":"Int","null_value":1,"comment":"Reactive Power Control Mode. 1 VoltVar Control, 2 Constant Q Control, 3 Constant PF Control","valid_range":{"max":3,"min":1}},{"name":"PQ_Flag","data_type":"Int","null_value":0,"comment":"Active and reactive power priority mode. 0 for Q priority, 1 for P priority","valid_range":{"max":1,"min":0}},{"name":"Gen_Flag","data_type":"Int","null_value":0,"comment":"Define generator or storage system. 0 unit is a storage device, 1 unit is a generator","valid_range":{"max":1,"min":0}},{"name":"PerOp_Flag","data_type":"Int","null_value":0,"comment":"Defines operation of permisible region in VRT characteristic. 0 for cease, 1 for continuous operation","valid_range":{"max":1,"min":0}},{"name":"Recon_Flag","data_type":"Int","null_value":0,"comment":"Defines if DER can reconnect after voltage ride-through disconnection","valid_range":{"max":1,"min":0}},{"name":"Trv","data_type":"Float64","null_value":0,"comment":"Voltage measurement transducer's time constant, in s","valid_range":{"max":null,"min":0}},{"name":"VV_pnts","data_type":"NamedTuple{(:V1, :V2, :V3, :V4), Tuple{Float64, Float64, Float64, Float64}}","null_value":"(V1=0.0, V2=0.0, V3=0.0, V4=0.0)","comment":"Y-axis Volt-var curve points (V1,V2,V3,V4)"},{"name":"Q_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Reactive power limits in pu (Q_min, Q_max)"},{"name":"Tp","data_type":"Float64","null_value":0,"comment":"Power measurement transducer's time constant, in s","valid_range":{"max":null,"min":0}},{"name":"e_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Error limit in PI controller for q control (e_min, e_max)"},{"name":"Kpq","data_type":"Float64","null_value":0,"comment":"PI controller proportional gain for q control","valid_range":{"max":null,"min":0}},{"name":"Kiq","data_type":"Float64","null_value":0,"comment":"PI controller integral gain for q control","valid_range":{"max":null,"min":0}},{"name":"Iqr_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Limit on rate of change for reactive current (pu/s) (Iqr_min, Iqr_max)"},{"name":"I_max","data_type":"Float64","null_value":0,"comment":"Max. inverter's current","valid_range":{"max":null,"min":0}},{"name":"Tg","data_type":"Float64","null_value":0,"comment":"Current control's time constant, in s","valid_range":{"max":null,"min":0}},{"name":"kWh_Cap","data_type":"Float64","null_value":0,"comment":"BESS capacity in kWh","valid_range":{"max":null,"min":0}},{"name":"SOC_ini","data_type":"Float64","null_value":0,"comment":"Initial state of charge (SOC) in pu","valid_range":{"max":1,"min":0}},{"name":"SOC_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Battery's SOC limits (SOC_min, SOC_max)"},{"name":"Trf","data_type":"Float64","null_value":0,"comment":"Time constant to estimate system frequency, in s","valid_range":{"max":null,"min":0}},{"name":"fdbd_pnts","data_type":"NamedTuple{(:fdbd1, :fdbd2), Tuple{Float64, Float64}}","null_value":"(fdbd1=0.0, fdbd2=0.0)","comment":"Frequency error dead band thresholds `(fdbd1, fdbd2)`"},{"name":"D_dn","data_type":"Float64","null_value":0,"comment":"reciprocal of droop for over-frequency conditions, in pu","valid_range":{"max":null,"min":0}},{"name":"D_up","data_type":"Float64","null_value":0,"comment":"reciprocal of droop for under-frequency conditions, in pu","valid_range":{"max":null,"min":0}},{"name":"fe_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Frequency error limits in pu (fe_min, fe_max)"},{"name":"Kpp","data_type":"Float64","null_value":0,"comment":"PI controller proportional gain for p control","valid_range":{"max":null,"min":0}},{"name":"Kip","data_type":"Float64","null_value":0,"comment":"PI controller integral gain for p control","valid_range":{"max":null,"min":0}},{"name":"P_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Active power limits in pu (P_min, P_max)"},{"name":"dP_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Ramp rate limits for active power in pu/s (dP_min, dP_max)"},{"name":"T_pord","data_type":"Float64","null_value":0,"comment":"Power filter time constant in s","valid_range":{"max":null,"min":0}},{"name":"rrpwr","data_type":"Float64","null_value":0,"comment":"Ramp rate for real power increase following a fault, in pu/s","valid_range":{"max":null,"min":0}},{"name":"VRT_pnts","data_type":"NamedTuple{(:vrt1, :vrt2, :vrt3, :vrt4, :vrt5), Tuple{Float64, Float64, Float64, Float64, Float64}}","null_value":"(vrt1=0.0, vrt2=0.0, vrt3=0.0, vrt4=0.0, vrt5=0.0)","comment":"Voltage ride through v points (vrt1,vrt2,vrt3,vrt4,vrt5)"},{"name":"TVRT_pnts","data_type":"NamedTuple{(:tvrt1, :tvrt2, :tvrt3), Tuple{Float64, Float64, Float64}}","null_value":"(tvrt1=0.0, tvrt2=0.0, tvrt3=0.0)","comment":"Voltage ride through time points (tvrt1,tvrt2,tvrt3)"},{"name":"tV_delay","data_type":"Float64","null_value":0,"comment":"Time delay for reconnection after voltage ride-through disconnection","valid_range":{"max":null,"min":0}},{"name":"VES_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Min and max voltage for entering service (VES_min,VES_max)"},{"name":"FRT_pnts","data_type":"NamedTuple{(:frt1, :frt2, :frt3, :frt4), Tuple{Float64, Float64, Float64, Float64}}","null_value":"(frt1=0.0, frt2=0.0, frt3=0.0, frt4=0.0)","comment":"Frequency ride through v points (frt1,frt2,frt3,frt4)"},{"name":"TFRT_pnts","data_type":"NamedTuple{(:tfrt1, :tfrt2), Tuple{Float64, Float64}}","null_value":"(tfrt1=0.0, tfrt2=0.0)","comment":"Frequency ride through time points (tfrt1,tfrt2)"},{"name":"tF_delay","data_type":"Float64","null_value":0,"comment":"Time delay for reconnection after frequency ride-through disconnection","valid_range":{"max":null,"min":0}},{"name":"FES_lim","data_type":"MinMax","null_value":"(min=0.0, max=0.0)","comment":"Min and max frequency for entering service (FES_min,FES_max)"},{"name":"Pfa_ref","default":"0.0","data_type":"Float64","null_value":0,"comment":"Reference power factor","valid_range":{"max":null,"min":0}},{"name":"Q_ref","default":"0.0","data_type":"Float64","null_value":0,"comment":"Reference reactive power, in pu","valid_range":{"max":null,"min":0}},{"name":"P_ref","default":"1.0","data_type":"Float64","null_value":0,"comment":"Reference active power, in pu","valid_range":{"max":null,"min":0}},{"name":"base_power","default":"100.0","data_type":"Float64","null_value":0,"comment":"Base power"},{"name":"states","data_type":"Vector{Symbol}","exclude_setter":true,"comment":"The states of GenericDER depend on the Flags","internal_default":"PowerSystems.get_GenericDER_states(Qref_Flag)[1]"},{"name":"n_states","data_type":"Int","exclude_setter":true,"comment":"The states of GenericDER depend on the Flags","internal_default":"PowerSystems.get_GenericDER_states(Qref_Flag)[2]"},{"name":"ext","default":"Dict{String, Any}()","data_type":"Dict{String, Any}","null_value":"Dict{String, Any}()"},{"name":"internal","data_type":"InfrastructureSystemsInternal","exclude_setter":true,"comment":"power system internal reference, do not modify","internal_default":"InfrastructureSystemsInternal()"}],"docstring":"Parameters of a Generic Distributed Energy Resource Model. Based on https://scholarspace.manoa.hawaii.edu/bitstream/10125/70994/0304.pdf","struct_name":"GenericDER","supertype":"DynamicInjection"},{"fields":[{"name":"device"},{"name":"droop","data_type":"Float64","valid_range":{"max":null,"min":0}},{"name":"participation_factor","data_type":"UpDown"},{"name":"reserve_limit_dn","data_type":"Float64","valid_range":{"max":null,"min":0}},{"name":"reserve_limit_up","data_type":"Float64","valid_range":{"max":null,"min":0}},{"name":"inertia","data_type":"Float64","valid_range":{"max":null,"min":0}},{"name":"cost","data_type":"Float64","valid_range":{"max":null,"min":0}},{"name":"time_series_container","data_type":"InfrastructureSystems.TimeSeriesContainer"},{"name":"internal","data_type":"InfrastructureSystems.InfrastructureSystemsInternal"}],"struct_name":"RegulationDevice"}]} \ No newline at end of file diff --git a/previews/PR360/tutorials/tutorial_240bus/index.html b/previews/PR360/tutorials/tutorial_240bus/index.html new file mode 100644 index 000000000..3df5a2e49 --- /dev/null +++ b/previews/PR360/tutorials/tutorial_240bus/index.html @@ -0,0 +1,480 @@ + +240 WECC solver comparison · PowerSimulationsDynamics.jl

    PSSE 240 Bus Case system with Renewables

    Originally Contributed by: José Daniel Lara

    Introduction

    This tutorial will introduce the industry models of Renewable Energy the comparisons between DiffEq Integration techniques for comparison. We show the uses of Sundials and OrdinaryDiffEq to obtain the transient response of a system to a perturbation.

    julia> using PowerSimulationsDynamics
    julia> using PowerSystemCaseBuilder
    julia> using PowerSystems
    julia> const PSY = PowerSystemsPowerSystems
    julia> using Sundials
    julia> using Plots
    julia> using OrdinaryDiffEq
    Note

    PowerSystemCaseBuilder.jl is a helper library that makes it easier to reproduce examples in the documentation and tutorials. Normally you would pass your local files to create the system data instead of calling the function build_system. For more details visit PowerSystemCaseBuilder Documentation

    Load the system and transform load data

    To load the system we use PowerSystemCaseBuilder.jl:

    julia> # We remove the checks in this example to avoid large prints
    +       sys = build_system(PSIDSystems, "WECC 240 Bus"; runchecks = false)
    +       
    +       # Transform the system's load┌ Info: Building new system WECC 240 Bus from raw data
    +└   sys_descriptor.raw_data = ""
    +┌ Warning: System is saved in the data format version 2.0.0 will be automatically upgraded to 3.0.0 upon saving
    +└ @ PowerSystems ~/.julia/packages/PowerSystems/diJIg/src/data_format_conversions.jl:82
    +┌ Warning: The System was deserialized with checks disabled, and so was not validated.
    +└ @ PowerSystems ~/.julia/packages/PowerSystems/diJIg/src/base.jl:1448
    +┌ Warning: System is saved in the data format version 2.0.0 will be automatically upgraded to 3.0.0 upon saving
    +└ @ PowerSystems ~/.julia/packages/PowerSystems/diJIg/src/data_format_conversions.jl:110
    +[ Info: Serialized System to /home/runner/.julia/packages/PowerSystemCaseBuilder/E76Gu/data/serialized_system/NoArgs/WECC 240 Bus.json
    +[ Info: Serialized System metadata to /home/runner/.julia/packages/PowerSystemCaseBuilder/E76Gu/data/serialized_system/NoArgs/WECC 240 Bus_metadata.json
    +System
    +┌───────────────────┬─────────────┐
    +│ Property          │ Value       │
    +├───────────────────┼─────────────┤
    +│ Name              │             │
    +│ Description       │             │
    +│ System Units Base │ SYSTEM_BASE │
    +│ Base Power        │ 100.0       │
    +│ Base Frequency    │ 60.0        │
    +│ Num Components    │ 1501        │
    +└───────────────────┴─────────────┘
    +
    +Static Components
    +┌─────────────────┬───────┬────────────────────────┬───────────────┐
    +│ Type            │ Count │ Has Static Time Series │ Has Forecasts │
    +├─────────────────┼───────┼────────────────────────┼───────────────┤
    +│ ACBus           │ 243   │ false                  │ false         │
    +│ Arc             │ 351   │ false                  │ false         │
    +│ Area            │ 4     │ false                  │ false         │
    +│ FixedAdmittance │ 7     │ false                  │ false         │
    +│ Line            │ 329   │ false                  │ false         │
    +│ LoadZone        │ 14    │ false                  │ false         │
    +│ StandardLoad    │ 139   │ false                  │ false         │
    +│ TapTransformer  │ 2     │ false                  │ false         │
    +│ ThermalStandard │ 146   │ false                  │ false         │
    +│ Transformer2W   │ 120   │ false                  │ false         │
    +└─────────────────┴───────┴────────────────────────┴───────────────┘
    +
    +Dynamic Components
    +┌──────────────────┬───────┐
    +│ Type             │ Count │
    +├──────────────────┼───────┤
    +│ DynamicGenerator │ 41    │
    +│ DynamicGenerator │ 6     │
    +│ DynamicGenerator │ 3     │
    +│ DynamicGenerator │ 1     │
    +│ DynamicGenerator │ 36    │
    +│ DynamicGenerator │ 22    │
    +│ DynamicInverter  │ 37    │
    +└──────────────────┴───────┘
    julia> for l in get_components(PSY.StandardLoad, sys) + transform_load_to_constant_impedance(l) + end┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81 +┌ Warning: Load data is transformed under the assumption of a 1.0 p.u. Voltage Magnitude +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/utils/psy_utils.jl:81

    Build the simulation and initialize the problem

    The next step is to create the simulation structure. This will create the indexing of our system that will be used to formulate the differential-algebraic system of equations. To do so, it is required to specify the perturbation that will occur in the system. In this case, we will use a ResidualModel formulation, for more details about the formulation checkout the Models Section in PowerSimulationsDynamics.jl documentation.

    julia> using Logging
    julia> sim_ida = Simulation( + ResidualModel, + sys, #system + pwd(), + (0.0, 20.0), #time span + BranchTrip(1.0, Line, "CORONADO -1101-PALOVRDE -1401-i_10"); + console_level = Logging.Info, + )[ Info: Unit System changed to UnitSystem.DEVICE_BASE = 1 +[ Info: Pre-Initializing Simulation States +[ Info: Unit System changed to UnitSystem.SYSTEM_BASE = 0 +┌ Warning: Unit generator-3631-NB set at the limit -0.14000000000000004. Q_max = 0.20000000000000004 Q_min = -0.14000000000000004 +└ @ PowerFlows ~/.julia/packages/PowerFlows/8MBjq/src/post_processing.jl:352 +┌ Warning: Unit generator-6132-G set at the limit -1.47. Q_max = 1.47 Q_min = -1.47 +└ @ PowerFlows ~/.julia/packages/PowerFlows/8MBjq/src/post_processing.jl:352 +┌ Warning: Unit generator-6433-E set at the limit 0.59. Q_max = 0.59 Q_min = -0.59 +└ @ PowerFlows ~/.julia/packages/PowerFlows/8MBjq/src/post_processing.jl:352 +[ Info: PowerFlow solve converged, the results have been stored in the system +[ Info: Unit System changed to UnitSystem.DEVICE_BASE = 1 +[ Info: Residual from initial guess: max = 9.82774084334892e-10 at 1268, total = 2.3309883363794544e-8 +Iter f(x) inf-norm Step 2-norm +------ -------------- -------------- +[ Info: Initialization non-linear solve succeeded with a tolerance of 1.0e-9 using solver trust_region. Saving solution. +[ Info: Attaching Perturbations +[ Info: Simulations status = BUILT +┌ Info: +│ ─────────────────────────────────────────────────────────────────────────────── +│ Time Allocations +│ ─────────────── ─────────────── +│ Total measured: 27.6s 4.82GiB +│ +│ Section ncalls time %tot alloc %tot +│ ─────────────────────────────────────────────────────────────────────────────── +│ Build Simulation 1 27.6s 100.0% 4.82GiB 100.0% +│ Build Simulation Inputs 1 2.82s 10.2% 152MiB 3.1% +│ Wrap Branches 1 12.2μs 0.0% 208B 0.0% +│ Wrap Dynamic Injectors 1 1.74s 6.3% 95.2MiB 1.9% +│ Calculate MM, DAE_vector, Tota... 1 236ms 0.9% 18.6MiB 0.4% +│ Wrap Static Injectors 1 298ms 1.1% 11.4MiB 0.2% +│ Pre-initialization 1 5.36s 19.4% 271MiB 5.5% +│ Power Flow solution 1 1.14s 4.1% 43.9MiB 0.9% +│ Initialize Static Injectors 1 1.18μs 0.0% 0.00B 0.0% +│ Initialize Dynamic Injectors 1 4.21s 15.3% 227MiB 4.6% +│ Calculate Jacobian 1 14.1s 51.2% 4.15GiB 86.2% +│ Make Model Function 1 27.0μs 0.0% 30.9KiB 0.0% +│ Initial Condition NLsolve refine... 1 4.81s 17.4% 249MiB 5.0% +│ Build Perturbations 1 126μs 0.0% 75.1KiB 0.0% +│ Make DiffEq Problem 1 470ms 1.7% 10.9MiB 0.2% +│ ─────────────────────────────────────────────────────────────────────────────── +└ +Simulation Summary +┌─────────────────────────┬────────────────┐ +│ Property │ Value │ +├─────────────────────────┼────────────────┤ +│ Status │ BUILT │ +│ Simulation Type │ Residual Model │ +│ Initialized? │ Yes │ +│ Multimachine system? │ Yes │ +│ Time Span │ (0.0, 20.0) │ +│ Number of States │ 2164 │ +│ Number of Perturbations │ 1 │ +└─────────────────────────┴────────────────┘

    Run the simulation using Sundials

    We will now run the simulation using Sundials.jl solver IDA() by specifying the maximum dt we want for the simulation. In our experience with this solver, solution times are faster when supplying information about the maximum time step than the tolerances as we can see in the example

    julia> execute!(sim_ida, IDA(), dtmax = 0.01)SIMULATION_FINALIZED::BUILD_STATUS = 6

    Read the results and plot a system variable

    After the simulation is completed, we can extract the results and make plots as desired. In this case, we will plot the voltage magnitude at the bus at which the line was connected.

    julia> res_ida = read_results(sim_ida)Simulation Results Summary
    +┌────────────────────────────┬──────────────┐
    +│ Property                   │ Value        │
    +├────────────────────────────┼──────────────┤
    +│ System Base Power [MVA]    │ 100.0        │
    +│ System Base Frequency [Hz] │ 60.0         │
    +│ Time Span                  │ (0.0, 20.0)  │
    +│ Total Time Steps           │ 2015         │
    +│ Number of States           │ 2164         │
    +│ Total solve time           │ 18.026563257 │
    +└────────────────────────────┴──────────────┘
    julia> v1101_ida = get_voltage_magnitude_series(res_ida, 1101);
    julia> plot(v1101_ida);

    plot

    Run the simulation using Rodas4()

    In this case, we will use a MassMatrixModel formulation, for more details about the formulation checkout the Models Section in PowerSimulationsDynamics.jl documentation

    julia> sim_rodas = Simulation(
    +           MassMatrixModel,
    +           sys, #system
    +           pwd(),
    +           (0.0, 20.0), #time span
    +           BranchTrip(1.0, Line, "CORONADO    -1101-PALOVRDE    -1401-i_10");
    +           console_level = Logging.Info,
    +       )[ Info: Unit System changed to UnitSystem.DEVICE_BASE = 1
    +[ Info: Pre-Initializing Simulation States
    +[ Info: Unit System changed to UnitSystem.SYSTEM_BASE = 0
    +┌ Warning: Unit generator-3631-NB set at the limit -0.14000000000000004. Q_max = 0.20000000000000004 Q_min = -0.14000000000000004
    +└ @ PowerFlows ~/.julia/packages/PowerFlows/8MBjq/src/post_processing.jl:352
    +┌ Warning: Unit generator-6132-G set at the limit -1.47. Q_max = 1.47 Q_min = -1.47
    +└ @ PowerFlows ~/.julia/packages/PowerFlows/8MBjq/src/post_processing.jl:352
    +┌ Warning: Unit generator-6433-E set at the limit 0.59. Q_max = 0.59 Q_min = -0.59
    +└ @ PowerFlows ~/.julia/packages/PowerFlows/8MBjq/src/post_processing.jl:352
    +[ Info: PowerFlow solve converged, the results have been stored in the system
    +[ Info: Unit System changed to UnitSystem.DEVICE_BASE = 1
    +[ Info: Residual from initial guess: max = 9.82774084334892e-10 at 1268, total = 2.3309883363794544e-8
    +Iter     f(x) inf-norm    Step 2-norm 
    +------   --------------   --------------
    +[ Info: Initialization non-linear solve succeeded with a tolerance of 1.0e-9 using solver trust_region. Saving solution.
    +[ Info: Attaching Perturbations
    +[ Info: Simulations status = BUILT
    +┌ Info: 
    +│  ───────────────────────────────────────────────────────────────────────────────
    +│                                                      Time          Allocations  
    +│                                                ───────────────   ───────────────
    +│                 Total measured:                     9.05s             799MiB    
    +│ 
    +│  Section                               ncalls     time    %tot     alloc    %tot
    +│  ───────────────────────────────────────────────────────────────────────────────
    +│  Build Simulation                           1    9.05s  100.0%    799MiB  100.0%
    +│    Build Simulation Inputs                  1   6.35ms    0.1%   7.32MiB    0.9%
    +│      Wrap Branches                          1   5.58μs    0.0%      208B    0.0%
    +│      Wrap Dynamic Injectors                 1   3.63ms    0.0%   2.44MiB    0.3%
    +│      Calculate MM, DAE_vector, Tota...      1    605μs    0.0%   1.90MiB    0.2%
    +│      Wrap Static Injectors                  1    453μs    0.0%    290KiB    0.0%
    +│    Pre-initialization                       1   16.1ms    0.2%   9.66MiB    1.2%
    +│      Power Flow solution                    1   10.8ms    0.1%   5.75MiB    0.7%
    +│      Initialize Static Injectors            1    771ns    0.0%     0.00B    0.0%
    +│      Initialize Dynamic Injectors           1   4.80ms    0.1%   3.75MiB    0.5%
    +│    Calculate Jacobian                       1    7.23s   79.9%    596MiB   74.6%
    +│    Make Model Function                      1   7.74ms    0.1%    152KiB    0.0%
    +│    Initial Condition NLsolve refine...      1    1.37s   15.1%    167MiB   21.0%
    +│    Build Perturbations                      1   18.1ms    0.2%    627KiB    0.1%
    +│    Make DiffEq Problem                      1    405ms    4.5%   17.7MiB    2.2%
    +│  ───────────────────────────────────────────────────────────────────────────────
    +└ 
    +Simulation Summary
    +┌─────────────────────────┬───────────────────┐
    +│ Property                │ Value             │
    +├─────────────────────────┼───────────────────┤
    +│ Status                  │ BUILT             │
    +│ Simulation Type         │ Mass Matrix Model │
    +│ Initialized?            │ Yes               │
    +│ Multimachine system?    │ Yes               │
    +│ Time Span               │ (0.0, 20.0)       │
    +│ Number of States        │ 2164              │
    +│ Number of Perturbations │ 1                 │
    +└─────────────────────────┴───────────────────┘

    We will now run the simulation using OrdinaryDiffEq.jl solver Rodas4() by specifying the tolerance we want for the simulation. In our experience with this solver, solution times are faster when supplying information about the atol and rtol values as we can see in the example. The solver will also work with a specified dtmax but take a significantly longer time to solve. When using OrdinaryDiffEq.jl solvers always pass the option initializealg = NoInit() to avoid unnecessary re-initialization of the algebraic equations.

    julia> execute!(
    +           sim_rodas,
    +           Rodas4(),
    +           saveat = 0.01,
    +           atol = 1e-10,
    +           rtol = 1e-10,
    +           initializealg = NoInit(),
    +       )SIMULATION_FINALIZED::BUILD_STATUS = 6

    Read the results

    After the simulation is completed, we can extract the results and make plots as desired. In this case, we will plot the voltage magnitude at the bus at which the line was connected.

    julia> res_rodas = read_results(sim_rodas)Simulation Results Summary
    +┌────────────────────────────┬──────────────┐
    +│ Property                   │ Value        │
    +├────────────────────────────┼──────────────┤
    +│ System Base Power [MVA]    │ 100.0        │
    +│ System Base Frequency [Hz] │ 60.0         │
    +│ Time Span                  │ (0.0, 20.0)  │
    +│ Total Time Steps           │ 2002         │
    +│ Number of States           │ 2164         │
    +│ Total solve time           │ 32.523154573 │
    +└────────────────────────────┴──────────────┘

    Compare the results

    After the simulation is completed, we can extract the results and make plots as desired. In this case, we will plot the voltage magnitude at the bus at which the line was connected. For both of the solution techniques.

    julia> v1101 = get_voltage_magnitude_series(res_rodas, 1101);
    julia> plot(v1101, label = "RODAS4");
    julia> plot!(v1101_ida, label = "IDA");

    plot

    diff --git a/previews/PR360/tutorials/tutorial_activeload/index.html b/previews/PR360/tutorials/tutorial_activeload/index.html new file mode 100644 index 000000000..8d7d45ec3 --- /dev/null +++ b/previews/PR360/tutorials/tutorial_activeload/index.html @@ -0,0 +1,270 @@ + +Active Load Model · PowerSimulationsDynamics.jl

    Tutorial Active Constant Power Load model

    Originally Contributed by: Rodrigo Henriquez-Auba

    Introduction

    This tutorial will introduce you to the functionality of PowerSimulationsDynamics and PowerSystems to explore active load components and a small-signal analysis.

    This tutorial presents a simulation of a two-bus system with a GFM inverter at bus 1, and a load on bus 2. We will change the model from a constant power load model, to a constant impedance model and then to a 12-state active constant power load model.

    Dependencies

    julia> using PowerSimulationsDynamics;
    julia> PSID = PowerSimulationsDynamicsPowerSimulationsDynamics
    julia> using PowerSystemCaseBuilder
    julia> using PowerSystems
    julia> const PSY = PowerSystems;
    Note

    PowerSystemCaseBuilder.jl is a helper library that makes it easier to reproduce examples in the documentation and tutorials. Normally you would pass your local files to create the system data instead of calling the function build_system. For more details visit PowerSystemCaseBuilder Documentation

    PowerSystems (abbreviated with PSY) is used to properly define the data structure and establish an equilibrium point initial condition with a power flow routine using PowerFlows.

    Load the system

    We load the system using PowerSystemCaseBuilder.jl. This system has an inverter located at bus 1.

    julia> sys = build_system(PSIDSystems, "2 Bus Load Tutorial Droop")┌ Info: Building new system 2 Bus Load Tutorial Droop from raw data
    +└   sys_descriptor.raw_data = "/home/runner/.julia/artifacts/2b7013812a985ce5884696ce276ca17b2719a57a/PowerSystemsTestData-2.0/psid_tests/data_examples/Omib_Load.raw"
    +[ Info: The PSS(R)E parser currently supports buses, loads, shunts, generators, branches, transformers, and dc lines
    +[ Info: The PSS(R)E parser currently supports buses, loads, shunts, generators, branches, transformers, and dc lines
    +[ Info: Parsing PSS(R)E Bus data into a PowerModels Dict...
    +[ Info: Parsing PSS(R)E Load data into a PowerModels Dict...
    +[ Info: Parsing PSS(R)E Shunt data into a PowerModels Dict...
    +[ Info: Parsing PSS(R)E Generator data into a PowerModels Dict...
    +[ Info: Parsing PSS(R)E Branch data into a PowerModels Dict...
    +[ Info: Parsing PSS(R)E Transformer data into a PowerModels Dict...
    +[ Info: Parsing PSS(R)E Two-Terminal and VSC DC line data into a PowerModels Dict...
    +┌ Warning: This PSS(R)E parser currently doesn't support Storage data parsing...
    +└ @ PowerSystems ~/.julia/packages/PowerSystems/diJIg/src/parsers/pm_io/psse.jl:986
    +┌ Warning: This PSS(R)E parser currently doesn't support Switch data parsing...
    +└ @ PowerSystems ~/.julia/packages/PowerSystems/diJIg/src/parsers/pm_io/psse.jl:992
    +[ Info: angmin and angmax values are 0, widening these values on branch 1 to +/- 60.0 deg.
    +┌ Info: Constructing System from Power Models
    +│   data["name"] = "omib_load"
    +└   data["source_type"] = "pti"
    +[ Info: Reading bus data
    +[ Info: Reading Load data in PowerModels dict to populate System ...
    +[ Info: Reading LoadZones data in PowerModels dict to populate System ...
    +[ Info: Reading generator data
    +[ Info: Reading branch data
    +[ Info: Reading branch data
    +[ Info: Reading DC Line data
    +[ Info: Reading storage data
    +[ Info: Serialized System to /home/runner/.julia/packages/PowerSystemCaseBuilder/E76Gu/data/serialized_system/NoArgs/2 Bus Load Tutorial Droop.json
    +[ Info: Serialized System metadata to /home/runner/.julia/packages/PowerSystemCaseBuilder/E76Gu/data/serialized_system/NoArgs/2 Bus Load Tutorial Droop_metadata.json
    +System
    +┌───────────────────┬─────────────┐
    +│ Property          │ Value       │
    +├───────────────────┼─────────────┤
    +│ Name              │             │
    +│ Description       │             │
    +│ System Units Base │ SYSTEM_BASE │
    +│ Base Power        │ 100.0       │
    +│ Base Frequency    │ 60.0        │
    +│ Num Components    │ 9           │
    +└───────────────────┴─────────────┘
    +
    +Static Components
    +┌─────────────────┬───────┬────────────────────────┬───────────────┐
    +│ Type            │ Count │ Has Static Time Series │ Has Forecasts │
    +├─────────────────┼───────┼────────────────────────┼───────────────┤
    +│ ACBus           │ 2     │ false                  │ false         │
    +│ Arc             │ 1     │ false                  │ false         │
    +│ Area            │ 1     │ false                  │ false         │
    +│ ExponentialLoad │ 1     │ false                  │ false         │
    +│ Line            │ 1     │ false                  │ false         │
    +│ LoadZone        │ 1     │ false                  │ false         │
    +│ ThermalStandard │ 1     │ false                  │ false         │
    +└─────────────────┴───────┴────────────────────────┴───────────────┘
    +
    +Dynamic Components
    +┌─────────────────┬───────┐
    +│ Type            │ Count │
    +├─────────────────┼───────┤
    +│ DynamicInverter │ 1     │
    +└─────────────────┴───────┘
    julia> first(get_components(DynamicInverter, sys))generator-101-1 (DynamicInverter{AverageConverter, OuterControl{ActivePowerDroop, ReactivePowerDroop}, VoltageModeControl, FixedDCSource, FixedFrequency, LCLFilter, Nothing}):
    +   name: generator-101-1
    +   ω_ref: 1.0
    +   converter: AverageConverter
    +   outer_control: OuterControl{ActivePowerDroop, ReactivePowerDroop}
    +   inner_control: VoltageModeControl
    +   dc_source: FixedDCSource
    +   freq_estimator: FixedFrequency
    +   filter: LCLFilter
    +   limiter: nothing
    +   base_power: 100.0
    +   n_states: 15
    +   states: [:θ_oc, :p_oc, :q_oc, :ξd_ic, :ξq_ic, :γd_ic, :γq_ic, :ϕd_ic, :ϕq_ic, :ir_cnv, :ii_cnv, :vr_filter, :vi_filter, :ir_filter, :ii_filter]
    +   ext: Dict{String, Any}()
    +   InfrastructureSystems.SystemUnitsSettings:
    +      base_value: 100.0
    +      unit_system: UnitSystem.SYSTEM_BASE = 0

    The load is an exponential load modeled as a constant power load since the coefficients are set to zero.

    julia> first(get_components(PSY.ExponentialLoad, sys))load1021 (PowerSystems.ExponentialLoad):
    +   name: load1021
    +   available: true
    +   bus: BUS 2 (ACBus)
    +   active_power: 0.1
    +   reactive_power: 0.032799999999999996
    +   active_power_coefficient: 0.0
    +   reactive_power_coefficient: 0.0
    +   base_power: 100.0
    +   max_active_power: 0.1
    +   max_reactive_power: 0.032799999999999996
    +   services: 0-element Vector{Service}
    +   dynamic_injector: nothing
    +   ext: Dict{String, Any}()
    +   time_series_container:
    +   InfrastructureSystems.SystemUnitsSettings:
    +      base_value: 100.0
    +      unit_system: UnitSystem.SYSTEM_BASE = 0

    Run a small-signal analysis

    We set up the Simulation. Since the droop model does not have a frequency state, we use a constant frequency reference frame for the network.

    julia> sim = Simulation(ResidualModel,
    +                       sys,
    +                       mktempdir(),
    +                       (0.0, 1.0),
    +                       frequency_reference = ConstantFrequency())[ Info: Unit System changed to UnitSystem.DEVICE_BASE = 1
    +Simulation Summary
    +┌─────────────────────────┬────────────────┐
    +│ Property                │ Value          │
    +├─────────────────────────┼────────────────┤
    +│ Status                  │ BUILT          │
    +│ Simulation Type         │ Residual Model │
    +│ Initialized?            │ Yes            │
    +│ Multimachine system?    │ No             │
    +│ Time Span               │ (0.0, 1.0)     │
    +│ Number of States        │ 19             │
    +│ Number of Perturbations │ 0              │
    +└─────────────────────────┴────────────────┘

    The following provides a summary of eigenvalues for this droop system with a constant power load:

    julia> sm = small_signal_analysis(sim);
    julia> df = summary_eigenvalues(sm);
    julia> show(df, allrows = true, allcols = true)15×6 DataFrame + Row │ Most Associated Part. Factor Real Part Imag. Part Damping [%] Freq [Hz] + │ Any Any Any Any Any Any +─────┼──────────────────────────────────────────────────────────────────────────────────────── + 1 │ generator-101-1 ii_filter 0.935337 -17394.7 0.0 100.0 2768.46 + 2 │ generator-101-1 ii_cnv 0.431047 -2971.58 -6377.16 42.2368 1119.74 + 3 │ generator-101-1 ii_cnv 0.431047 -2971.58 6377.16 42.2368 1119.74 + 4 │ generator-101-1 ir_cnv 0.437046 -2495.77 -5920.94 38.8419 1022.64 + 5 │ generator-101-1 ir_cnv 0.437046 -2495.77 5920.94 38.8419 1022.64 + 6 │ generator-101-1 ξd_ic 0.81633 -532.334 0.0 100.0 84.7237 + 7 │ generator-101-1 ξq_ic 0.82722 -459.814 0.0 100.0 73.1817 + 8 │ generator-101-1 p_oc 0.99997 -125.664 0.0 100.0 20.0 + 9 │ generator-101-1 q_oc 0.999564 -125.449 0.0 100.0 19.9659 + 10 │ generator-101-1 ϕd_ic 0.551981 -50.8211 0.0 100.0 8.08843 + 11 │ generator-101-1 ϕq_ic 0.551633 -50.7805 0.0 100.0 8.08197 + 12 │ generator-101-1 γd_ic 0.663765 -11.3952 0.0 100.0 1.81359 + 13 │ generator-101-1 γq_ic 0.664033 -11.3893 0.0 100.0 1.81266 + 14 │ generator-101-1 θ_oc 1.0 -0.0 0.0 NaN 0.0 + 15 │ generator-101-1 ir_filter 0.94952 17272.3 0.0 -100.0 2748.98

    In this inverter model, the filter is modeled using differential equations, and as described in the literature, interfacing a RL filter against an algebraic constant power load usually results in unstable behavior as observed with the positive real part eigenvalue.

    Change to a constant impedance load model

    Since the load is an exponential load model we can change the exponent coefficients to 2.0 to behave as a constant impedance model:

    julia> # Update load coefficients to 2.0
    +       load = first(get_components(PSY.ExponentialLoad, sys));
    julia> PSY.set_active_power_coefficient!(load, 2.0);
    julia> PSY.set_reactive_power_coefficient!(load, 2.0);

    We then re-run the small-signal analysis:

    julia> sim = Simulation(ResidualModel,
    +                       sys,
    +                       mktempdir(),
    +                       (0.0, 1.0),
    +                       frequency_reference = ConstantFrequency())[ Info: Unit System changed to UnitSystem.DEVICE_BASE = 1
    +Simulation Summary
    +┌─────────────────────────┬────────────────┐
    +│ Property                │ Value          │
    +├─────────────────────────┼────────────────┤
    +│ Status                  │ BUILT          │
    +│ Simulation Type         │ Residual Model │
    +│ Initialized?            │ Yes            │
    +│ Multimachine system?    │ No             │
    +│ Time Span               │ (0.0, 1.0)     │
    +│ Number of States        │ 19             │
    +│ Number of Perturbations │ 0              │
    +└─────────────────────────┴────────────────┘
    julia> sm = small_signal_analysis(sim);
    julia> df = summary_eigenvalues(sm);
    julia> show(df, allrows = true, allcols = true)15×6 DataFrame + Row │ Most Associated Part. Factor Real Part Imag. Part Damping [%] Freq [Hz] + │ Any Any Any Any Any Any +─────┼───────────────────────────────────────────────────────────────────────────────────────── + 1 │ generator-101-1 ir_filter 0.47969 -17387.8 -4716.08 96.513 2867.34 + 2 │ generator-101-1 ir_filter 0.47969 -17387.8 4716.08 96.513 2867.34 + 3 │ generator-101-1 ii_cnv 0.246681 -3144.63 -6413.81 44.0225 1136.88 + 4 │ generator-101-1 ii_cnv 0.246681 -3144.63 6413.81 44.0225 1136.88 + 5 │ generator-101-1 ir_cnv 0.249406 -2819.8 -6135.34 41.7606 1074.66 + 6 │ generator-101-1 ir_cnv 0.249406 -2819.8 6135.34 41.7606 1074.66 + 7 │ generator-101-1 ξq_ic 0.454519 -464.905 -16.1851 99.9395 74.0368 + 8 │ generator-101-1 ξq_ic 0.454519 -464.905 16.1851 99.9395 74.0368 + 9 │ generator-101-1 q_oc 0.991037 -126.084 0.0 100.0 20.067 + 10 │ generator-101-1 p_oc 0.99185 -125.663 0.0 100.0 20.0 + 11 │ generator-101-1 ϕq_ic 0.491934 -50.7962 -0.0190757 100.0 8.08447 + 12 │ generator-101-1 ϕq_ic 0.491934 -50.7962 0.0190757 100.0 8.08447 + 13 │ generator-101-1 γq_ic 0.488883 -11.391 -0.00268224 100.0 1.81293 + 14 │ generator-101-1 γq_ic 0.488883 -11.391 0.00268224 100.0 1.81293 + 15 │ generator-101-1 θ_oc 1.0 -0.0 0.0 NaN 0.0

    Observe that now the system is small-signal stable (since there is only one device the angle of the inverter is used as a reference, and hence is zero).

    Adding a dynamic active load model

    To consider a dynamic model in the load it is only required to attach a dynamic component to the static load model. When a dynamic load model is attached, the active and reactive power of the static model are used to define reference parameters to ensure that the dynamic load model matches the static load output power.

    Note that when a dynamic model is attached to a static model, the static model does not participate in the dynamic system equations, i.e. the only model interfacing to the network equations is the dynamic model and not the static model (the exponential load).

    We define a function to create a active load model with the specific parameters:

    julia> # Parameters taken from active load model from N. Bottrell Masters
    +       # Thesis "Small-Signal Analysis of Active Loads and Large-signal Analysis
    +       # of Faults in Inverter Interfaced Microgrid Applications", 2014.
    +       
    +       # The parameters are then per-unitized to be scalable to represent an aggregation
    +       # of multiple active loads
    +       
    +       # Base AC Voltage: Vb = 380 V
    +       # Base Power (AC and DC): Pb = 10000 VA
    +       # Base AC Current: Ib = 10000 / 380 = 26.32 A
    +       # Base AC Impedance: Zb = 380 / 26.32 =  14.44 Ω
    +       # Base AC Inductance: Lb = Zb / Ωb = 14.44 / 377 = 0.3831 H
    +       # Base AC Capacitance: Cb = 1 / (Zb * Ωb) = 0.000183697 F
    +       # Base DC Voltage: Vb_dc = (√8/√3) Vb = 620.54 V
    +       # Base DC Current: Ib_dc = Pb / V_dc = 10000/620.54 = 16.12 A
    +       # Base DC Impedance: Zb_dc = Vb_dc / Ib_dc = 38.50 Ω
    +       # Base DC Capacitance: Cb_dc = 1 / (Zb_dc * Ωb) = 6.8886315e-5 F
    +       
    +       Ωb = 2*pi*60;
    julia> Vb = 380;
    julia> Pb = 10000;
    julia> Ib = Pb / Vb;
    julia> Zb = Vb / Ib;
    julia> Lb = Zb / Ωb;
    julia> Cb = 1 / (Zb * Ωb);
    julia> Vb_dc = sqrt(8)/sqrt(3) * Vb;
    julia> Ib_dc = Pb / Vb_dc;
    julia> Zb_dc = Vb_dc / Ib_dc;
    julia> Cb_dc = 1/(Zb_dc * Ωb);
    julia> function active_cpl(load) + return PSY.ActiveConstantPowerLoad( + name = get_name(load), + r_load = 70.0 / Zb_dc, + c_dc = 2040e-6 / Cb_dc, + rf = 0.1 / Zb, + lf = 2.3e-3 / Lb, + cf = 8.8e-6 / Cb, + rg = 0.03 / Zb, + lg = 0.93e-3 / Lb, + kp_pll = 0.4, + ki_pll = 4.69, + kpv = 0.5 * (Vb_dc / Ib_dc), + kiv = 150.0 * (Vb_dc / Ib_dc), + kpc = 15.0 * (Ib / Vb), + kic = 30000.0 * (Ib / Vb), + base_power = 100.0, + ) + endactive_cpl (generic function with 1 method)

    We then attach the model to the system:

    julia> load = first(get_components(PSY.ExponentialLoad, sys));
    julia> dyn_load = active_cpl(load) +load1021 (ActiveConstantPowerLoad): + name: load1021 + r_load: 1.8178670360110796 + c_dc: 29.61400952076375 + rf: 0.006925207756232687 + lf: 0.0600470617999157 + cf: 0.04790501540123547 + rg: 0.0020775623268698058 + lg: 0.024279898901705045 + kp_pll: 0.4 + ki_pll: 4.69 + kpv: 19.25333333333334 + kiv: 5776.000000000003 + kpc: 1.038781163434903 + kic: 2077.562326869806 + base_power: 100.0 + ext: Dict{String, Any}() + P_ref: 1.0 + Q_ref: 1.0 + V_ref: 1.0 + ω_ref: 1.0 + is_filter_differential: 1 + states: [:θ_pll, :ϵ_pll, :η, :v_dc, :γd, :γq, :ir_cnv, :ii_cnv, :vr_filter, :vi_filter, :ir_filter, :ii_filter] + n_states: 12 + internal: InfrastructureSystems.InfrastructureSystemsInternal
    julia> add_component!(sys, dyn_load, load)

    Finally, we set up the simulation:

    julia> sim = Simulation(ResidualModel,
    +                       sys,
    +                       mktempdir(),
    +                       (0.0, 1.0),
    +                       frequency_reference = ConstantFrequency())[ Info: Unit System changed to UnitSystem.DEVICE_BASE = 1
    +Simulation Summary
    +┌─────────────────────────┬────────────────┐
    +│ Property                │ Value          │
    +├─────────────────────────┼────────────────┤
    +│ Status                  │ BUILT          │
    +│ Simulation Type         │ Residual Model │
    +│ Initialized?            │ Yes            │
    +│ Multimachine system?    │ No             │
    +│ Time Span               │ (0.0, 1.0)     │
    +│ Number of States        │ 31             │
    +│ Number of Perturbations │ 0              │
    +└─────────────────────────┴────────────────┘
    julia> sm = small_signal_analysis(sim);
    julia> df = summary_eigenvalues(sm);
    julia> show(df, allrows = true, allcols = true)27×6 DataFrame + Row │ Most Associated Part. Factor Real Part Imag. Part Damping [%] Freq [Hz] + │ Any Any Any Any Any Any +─────┼──────────────────────────────────────────────────────────────────────────────────────── + 1 │ generator-101-1 vi_filter 0.166385 -2778.16 -6703.69 38.2849 1154.92 + 2 │ generator-101-1 vi_filter 0.166385 -2778.16 6703.69 38.2849 1154.92 + 3 │ generator-101-1 vr_filter 0.209778 -2607.5 -6520.11 37.1323 1117.61 + 4 │ generator-101-1 vr_filter 0.209778 -2607.5 6520.11 37.1323 1117.61 + 5 │ load1021 vi_filter 0.189073 -2497.54 -7644.75 31.0548 1279.99 + 6 │ load1021 vi_filter 0.189073 -2497.54 7644.75 31.0548 1279.99 + 7 │ load1021 vr_filter 0.209271 -2302.82 -8223.34 26.9661 1359.13 + 8 │ load1021 vr_filter 0.209271 -2302.82 8223.34 26.9661 1359.13 + 9 │ generator-101-1 ii_filter 0.200819 -970.335 -1219.65 62.2586 248.052 + 10 │ generator-101-1 ii_filter 0.200819 -970.335 1219.65 62.2586 248.052 + 11 │ generator-101-1 ξq_ic 0.370911 -848.095 -73.6514 99.625 135.487 + 12 │ generator-101-1 ξq_ic 0.370911 -848.095 73.6514 99.625 135.487 + 13 │ load1021 η 0.379645 -326.767 -222.502 82.6572 62.9183 + 14 │ load1021 η 0.379645 -326.767 222.502 82.6572 62.9183 + 15 │ load1021 v_dc 0.161176 -238.623 -832.086 27.5666 137.769 + 16 │ load1021 v_dc 0.161176 -238.623 832.086 27.5666 137.769 + 17 │ load1021 θ_pll 0.465358 -132.89 0.0 100.0 21.15 + 18 │ generator-101-1 p_oc 0.995436 -125.653 0.0 100.0 19.9983 + 19 │ generator-101-1 q_oc 0.677379 -122.337 0.0 100.0 19.4706 + 20 │ load1021 ir_filter 0.410934 -57.5328 -1.7406e6 0.00330534 2.77026e5 + 21 │ load1021 ir_filter 0.410934 -57.5328 1.7406e6 0.00330534 2.77026e5 + 22 │ generator-101-1 ϕd_ic 0.527692 -50.8398 0.0 100.0 8.09141 + 23 │ generator-101-1 ϕq_ic 0.523655 -50.7749 0.0 100.0 8.08108 + 24 │ load1021 ϵ_pll 0.907233 -12.8266 0.0 100.0 2.04141 + 25 │ generator-101-1 γd_ic 0.944549 -11.3935 0.0 100.0 1.81333 + 26 │ generator-101-1 γq_ic 0.934217 -11.391 0.0 100.0 1.81294 + 27 │ generator-101-1 θ_oc 1.0 -0.0 0.0 NaN 0.0

    Observe the new states of the active load model and that the system is small-signal stable.

    diff --git a/previews/PR360/tutorials/tutorial_continuation_pf/index.html b/previews/PR360/tutorials/tutorial_continuation_pf/index.html new file mode 100644 index 000000000..a79a873a9 --- /dev/null +++ b/previews/PR360/tutorials/tutorial_continuation_pf/index.html @@ -0,0 +1,170 @@ + +Small-Signal Analysis · PowerSimulationsDynamics.jl

    Tutorial Small Signal Analysis with Continuation Power Flow

    Originally Contributed by: Rodrigo Henriquez-Auba

    Introduction

    This tutorial will introduce you to the functionality of PowerSimulationsDynamics and PowerFlows for running small signal analysis in a continuation power flow.

    This tutorial presents a simulation of a two-bus system with a generator (represented with a GENROU + SEXS + TGOV1 model) at bus 1, and a load on bus 2. We will increase the load demand to observe the P-V curve and run a small-signal analysis to check if the system satisfies small-signal stability at different operating points.

    Dependencies

    julia> using PowerSimulationsDynamics
    julia> PSID = PowerSimulationsDynamicsPowerSimulationsDynamics
    julia> using PowerSystemCaseBuilder
    julia> using PowerSystems
    julia> using PowerFlows
    julia> const PSY = PowerSystemsPowerSystems
    julia> using Plots
    julia> gr() + + # Disable Logging to avoid excessive informationPlots.GRBackend()
    julia> using Logging
    julia> Logging.disable_logging(Logging.Info);
    julia> Logging.disable_logging(Logging.Warn);
    Note

    PowerSystemCaseBuilder.jl is a helper library that makes it easier to reproduce examples in the documentation and tutorials. Normally you would pass your local files to create the system data instead of calling the function build_system. For more details visit PowerSystemCaseBuilder Documentation

    PowerSystems (abbreviated with PSY) is used to properly define the data structure and establish an equilibrium point initial condition with a power flow routine using PowerFlows.

    Load the system

    We load the system using PowerSystemCaseBuilder.jl. This system only have a generator without dynamic data on which we can use PowerFlows to generate a P-V (or nose) curve.

    julia> sys_static = build_system(PSIDSystems, "2 Bus Load Tutorial")System
    +┌───────────────────┬─────────────┐
    +│ Property          │ Value       │
    +├───────────────────┼─────────────┤
    +│ Name              │             │
    +│ Description       │             │
    +│ System Units Base │ SYSTEM_BASE │
    +│ Base Power        │ 100.0       │
    +│ Base Frequency    │ 60.0        │
    +│ Num Components    │ 8           │
    +└───────────────────┴─────────────┘
    +
    +Static Components
    +┌─────────────────┬───────┬────────────────────────┬───────────────┐
    +│ Type            │ Count │ Has Static Time Series │ Has Forecasts │
    +├─────────────────┼───────┼────────────────────────┼───────────────┤
    +│ ACBus           │ 2     │ false                  │ false         │
    +│ Arc             │ 1     │ false                  │ false         │
    +│ Area            │ 1     │ false                  │ false         │
    +│ ExponentialLoad │ 1     │ false                  │ false         │
    +│ Line            │ 1     │ false                  │ false         │
    +│ LoadZone        │ 1     │ false                  │ false         │
    +│ ThermalStandard │ 1     │ false                  │ false         │
    +└─────────────────┴───────┴────────────────────────┴───────────────┘

    Note that this system contains an Exponential Load, but the parameters are set up to zero, so it behaves a Constant Power Load:

    julia> first(get_components(PSY.ExponentialLoad, sys_static))load1021 (PowerSystems.ExponentialLoad):
    +   name: load1021
    +   available: true
    +   bus: BUS 2 (ACBus)
    +   active_power: 0.1
    +   reactive_power: 0.032799999999999996
    +   active_power_coefficient: 0.0
    +   reactive_power_coefficient: 0.0
    +   base_power: 100.0
    +   max_active_power: 0.1
    +   max_reactive_power: 0.032799999999999996
    +   services: 0-element Vector{Service}
    +   dynamic_injector: nothing
    +   ext: Dict{String, Any}()
    +   time_series_container:
    +   InfrastructureSystems.SystemUnitsSettings:
    +      base_value: 100.0
    +      unit_system: UnitSystem.SYSTEM_BASE = 0

    Create a P-V curve

    The next step is to run multiple power flows and store the voltage at the load and the active power. For this example we will set up the power factor to be unitary (i.e. no reactive power at the load).

    julia> # Create a Power Range to change the power load active power
    +       P_range = 0.01:0.01:4.6;
    +       # Choose the power factor
    julia> load_pf = 1.0;

    Then create vectors to store the results

    julia> # PV Curve Results
    +       P_load_p = Vector{Float64}();
    julia> V_load_p = Vector{Float64}();

    Then, we run multiple power flows in a for loop by changing the active power of the load:

    julia> for p in P_range
    +           # Change the active power and reactive power of the load
    +           power = p * 1.0
    +           load = get_component(PSY.ExponentialLoad, sys_static, "load1021")
    +           set_active_power!(load, power)
    +           q_power = power * tan(acos(load_pf))
    +           set_reactive_power!(load, q_power)
    +           # Run Power Flow
    +           status = solve_ac_powerflow!(sys_static)
    +           if !status
    +               # Finish the loop if the power flow fails
    +               print("Power Flow failed at p = $(power)")
    +               break
    +           end
    +           # Obtain the bus voltage information
    +           bus = get_component(Bus, sys_static, "BUS 2")
    +           Vm = get_magnitude(bus)
    +           # Store values in the vectors
    +           push!(V_load_p, Vm)
    +           push!(P_load_p, power)
    +       end┌ Error: The powerflow solver returned convergence = false
    +└ @ PowerFlows ~/.julia/packages/PowerFlows/8MBjq/src/nlsolve_ac_powerflow.jl:153
    +┌ Error: The powerflow solver returned convergence = false
    +└ @ PowerFlows ~/.julia/packages/PowerFlows/8MBjq/src/nlsolve_ac_powerflow.jl:52
    +Power Flow failed at p = 4.53

    The plot can be visualized with:

    julia> plot(P_load_p,
    +            V_load_p,
    +            label = "PV Curve",
    +            xlabel = "Load Power [pu]",
    +            ylabel = "Load Bus Voltage [pu]",
    +            color = :black
    +       )Plot{Plots.GRBackend() n=1}

    plot

    Run Small-Signal Analysis besides the Continuation Power Flow

    To run a small-signal analysis we require a dynamic model of the machine. We can use PowerSystemCaseBuilder to the load the same system, but with a dynamic model for the generator, including a GENROU + SEXS exciter + TGOV1 governor.

    julia> sys = build_system(PSIDSystems, "2 Bus Load Tutorial GENROU")System
    +┌───────────────────┬─────────────┐
    +│ Property          │ Value       │
    +├───────────────────┼─────────────┤
    +│ Name              │             │
    +│ Description       │             │
    +│ System Units Base │ SYSTEM_BASE │
    +│ Base Power        │ 100.0       │
    +│ Base Frequency    │ 60.0        │
    +│ Num Components    │ 9           │
    +└───────────────────┴─────────────┘
    +
    +Static Components
    +┌─────────────────┬───────┬────────────────────────┬───────────────┐
    +│ Type            │ Count │ Has Static Time Series │ Has Forecasts │
    +├─────────────────┼───────┼────────────────────────┼───────────────┤
    +│ ACBus           │ 2     │ false                  │ false         │
    +│ Arc             │ 1     │ false                  │ false         │
    +│ Area            │ 1     │ false                  │ false         │
    +│ ExponentialLoad │ 1     │ false                  │ false         │
    +│ Line            │ 1     │ false                  │ false         │
    +│ LoadZone        │ 1     │ false                  │ false         │
    +│ ThermalStandard │ 1     │ false                  │ false         │
    +└─────────────────┴───────┴────────────────────────┴───────────────┘
    +
    +Dynamic Components
    +┌──────────────────┬───────┐
    +│ Type             │ Count │
    +├──────────────────┼───────┤
    +│ DynamicGenerator │ 1     │
    +└──────────────────┴───────┘

    Here are the components of the generator:

    julia> first(get_components(DynamicGenerator, sys))generator-101-1 (DynamicGenerator{RoundRotorQuadratic, SingleMass, SEXS, SteamTurbineGov1, PSSFixed}):
    +   name: generator-101-1
    +   ω_ref: 1.0
    +   machine: RoundRotorQuadratic
    +   shaft: SingleMass
    +   avr: SEXS
    +   prime_mover: SteamTurbineGov1
    +   pss: PSSFixed
    +   base_power: 100.0
    +   n_states: 10
    +   states: [:eq_p, :ed_p, :ψ_kd, :ψ_kq, :δ, :ω, :Vf, :Vr, :x_g1, :x_g2]
    +   ext: Dict{String, Any}()
    +   InfrastructureSystems.SystemUnitsSettings:
    +      base_value: 100.0
    +      unit_system: UnitSystem.SYSTEM_BASE = 0

    Besides the results of the P-V curve, we need to store if the system is small-signal stable or not by looking if there is a positive real part eigenvalue.

    julia> # Vectors to store stability using a boolean (true for stable).
    +       stable_vec = Vector{Bool}();
    julia> status_vec = Vector{Bool}(); + + # PV Curve Results
    julia> P_load_p = Vector{Float64}();
    julia> V_load_p = Vector{Float64}();

    We then run the main for loop by updating the load active power, but in addition we create a PowerSimulationsDynamics simulation on which we can run a small-signal analysis to check stability.

    julia> for p in P_range
    +           # Change the active power and reactive power of the load
    +           power = p * 1.0
    +           load = get_component(PSY.ExponentialLoad, sys_static, "load1021")
    +           set_active_power!(load, power)
    +           q_power = power * tan(acos(load_pf))
    +           set_reactive_power!(load, q_power)
    +           # Run Power Flow
    +           status = solve_ac_powerflow!(sys_static)
    +           if !status
    +               # Finish the loop if the power flow fails
    +               print("Power Flow failed at p = $(power)")
    +               break
    +           end
    +           # Obtain the bus voltage information
    +           bus = get_component(Bus, sys_static, "BUS 2")
    +           Vm = get_magnitude(bus)
    +           # Store values in the vectors
    +           push!(V_load_p, Vm)
    +           push!(P_load_p, power)
    +       
    +           # Update Load Power in the GENROU system
    +           load = get_component(PSY.ExponentialLoad, sys, "load1021")
    +           set_active_power!(load, power)
    +           q_power = power * tan(acos(load_pf))
    +           set_reactive_power!(load, q_power)
    +           # Construct Simulation
    +           sim = Simulation(ResidualModel, sys, mktempdir(), (0.0, 1.0))
    +           if sim.status == PSID.BUILT
    +               # Check small-signal stability
    +               sm = small_signal_analysis(sim).stable
    +               # Push results of small-signal stability
    +               push!(stable_vec, sm)
    +               # Push results if the simulation was able to be constructed
    +               push!(status_vec, true)
    +           else
    +               # Push results if the simulation was not able to be constructed
    +               push!(status_vec, false)
    +           end
    +       end┌ Error: The powerflow solver returned convergence = false
    +└ @ PowerFlows ~/.julia/packages/PowerFlows/8MBjq/src/nlsolve_ac_powerflow.jl:153
    +┌ Error: The powerflow solver returned convergence = false
    +└ @ PowerFlows ~/.julia/packages/PowerFlows/8MBjq/src/nlsolve_ac_powerflow.jl:52
    +Power Flow failed at p = 4.53

    The following plot showcases the P-V curve, while also showcasing (in red) the regions on which the system is small-signal stable.

    julia> # Find where is stable and unstable
    +       dict_true_ixs_p = Vector();
    julia> dict_false_ixs_p = Vector();
    julia> dict_true_ixs_p = findall(x->x, stable_vec);
    julia> dict_false_ixs_p = findall(x->!x, stable_vec); + + # Create plot
    julia> true_ixs = dict_true_ixs_p;
    julia> plot(P_load_p, V_load_p, color = :blue, label = "PV Curve", xlabel = "Load Power [pu]", ylabel = "Load Bus Voltage [pu]")Plot{Plots.GRBackend() n=1}
    julia> plot!(Plots.scatter!(P_load_p[true_ixs] , V_load_p[true_ixs], markerstrokewidth= 0, label = "GENROU SSA"))Plot{Plots.GRBackend() n=2}

    plot

    This results is consistent with most of the literature for dynamic generator models supplying constant power loads, on which by increasing the active power of the load, produce critical eigenvalues which cross the $j\omega$ axis at some point. This is called a Hopf Bifurcation, in this case a subcritical one since the limit cycles are unstable.

    diff --git a/previews/PR360/tutorials/tutorial_dynamic_data/index.html b/previews/PR360/tutorials/tutorial_dynamic_data/index.html new file mode 100644 index 000000000..87f78e8e2 --- /dev/null +++ b/previews/PR360/tutorials/tutorial_dynamic_data/index.html @@ -0,0 +1,273 @@ + +Create Dynamic Data · PowerSimulationsDynamics.jl

    Creating and Handling Data for Dynamic Simulations

    Originally Contributed by: Rodrigo Henriquez and José Daniel Lara

    Introduction

    This tutorial briefly introduces how to create a system using PowerSystems.jl data structures. For more details visit PowerSystems.jl Documentation

    Start by calling PowerSystems.jl and PowerSystemCaseBuilder.jl:

    julia> using PowerSystems
    julia> using PowerSystemCaseBuilder
    julia> const PSY = PowerSystems;
    Note

    PowerSystemCaseBuilder.jl is a helper library that makes it easier to reproduce examples in the documentation and tutorials. Normally you would pass your local files to create the system data instead of calling the function build_system. For more details visit PowerSystemCaseBuilder Documentation

    System description

    Next we need to define the different elements required to run a simulation. To run a simulation in PowerSimulationsDynamics, it is required to define a System that contains the following components:

    Static Components

    We called static components to those that are used to run a Power Flow problem.

    • Vector of Bus elements, that define all the buses in the network.
    • Vector of Branch elements, that define all the branches elements (that connect two buses) in the network.
    • Vector of StaticInjection elements, that define all the devices connected to buses that can inject (or withdraw) power. These static devices, typically generators, in PowerSimulationsDynamics are used to solve the Power Flow problem that determines the active and reactive power provided for each device.
    • Vector of PowerLoad elements, that define all the loads connected to buses that can withdraw current. These are also used to solve the Power Flow.
    • Vector of Source elements, that define source components behind a reactance that can inject or withdraw current.
    • The base of power used to define per unit values, in MVA as a Float64 value.
    • The base frequency used in the system, in Hz as a Float64 value.

    Dynamic Components

    Dynamic components are those that define differential equations to run a transient simulation.

    • Vector of DynamicInjection elements. These components must be attached to a StaticInjection that connects the power flow solution to the dynamic formulation of such device. DynamicInjection can be DynamicGenerator or DynamicInverter, and its specific formulation (i.e. differential equations) will depend on the specific components that define such device.
    • (Optional) Selecting which of the Lines (of the Branch vector) elements must be modeled of DynamicLines elements, that can be used to model lines with differential equations.

    To start we will define the data structures for the network.

    Three Bus case manual data creation

    The following describes the system creation for this dynamic simulation case.

    Static System creation

    To create the system you need to load data using PowerSystemCaseBuilder.jl. This system was originally created from following raw file.

    julia> sys = build_system(PSIDSystems, "3 Bus Inverter Base"; force_build=true)System
    +┌───────────────────┬─────────────┐
    +│ Property          │ Value       │
    +├───────────────────┼─────────────┤
    +│ Name              │             │
    +│ Description       │             │
    +│ System Units Base │ SYSTEM_BASE │
    +│ Base Power        │ 100.0       │
    +│ Base Frequency    │ 60.0        │
    +│ Num Components    │ 16          │
    +└───────────────────┴─────────────┘
    +
    +Static Components
    +┌─────────────────┬───────┬────────────────────────┬───────────────┐
    +│ Type            │ Count │ Has Static Time Series │ Has Forecasts │
    +├─────────────────┼───────┼────────────────────────┼───────────────┤
    +│ ACBus           │ 3     │ false                  │ false         │
    +│ Arc             │ 3     │ false                  │ false         │
    +│ Area            │ 1     │ false                  │ false         │
    +│ Line            │ 3     │ false                  │ false         │
    +│ LoadZone        │ 1     │ false                  │ false         │
    +│ StandardLoad    │ 3     │ false                  │ false         │
    +│ ThermalStandard │ 2     │ false                  │ false         │
    +└─────────────────┴───────┴────────────────────────┴───────────────┘

    This system does not have an injection device in bus 1 (the reference bus). We can add a source with small impedance directly as follows:

    julia> slack_bus = [b for b in get_components(ACBus, sys) if get_bustype(b) == ACBusTypes.REF][1]BUS 1 (ACBus):
    +   number: 101
    +   name: BUS 1
    +   bustype: ACBusTypes.REF = 3
    +   angle: 0.0
    +   magnitude: 1.02
    +   voltage_limits: (min = 0.9, max = 1.1)
    +   base_voltage: 138.0
    +   area: 1 (Area)
    +   load_zone: 1 (LoadZone)
    +   ext: Dict{String, Any}()
    +   InfrastructureSystems.SystemUnitsSettings:
    +      base_value: 100.0
    +      unit_system: UnitSystem.SYSTEM_BASE = 0
    julia> inf_source = Source( + name = "InfBus", #name + available = true, #availability + active_power = 0.0, + reactive_power = 0.0, + bus = slack_bus, #bus + R_th = 0.0, #Rth + X_th = 5e-6, #Xth + ) +InfBus (Source): + name: InfBus + available: true + bus: BUS 1 (ACBus) + active_power: 0.0 + reactive_power: 0.0 + R_th: 0.0 + X_th: 5.0e-6 + internal_voltage: 1.0 + internal_angle: 0.0 + dynamic_injector: nothing + services: 0-element Vector{Service} + ext: Dict{String, Any}() + internal: InfrastructureSystems.InfrastructureSystemsInternal
    julia> add_component!(sys, inf_source)

    We just added a infinite source with $X_{th} = 5\cdot 10^{-6}$ pu. The system can be explored directly using functions like:

    julia> show_components(sys, Source)Source
    +┌────────┬───────────┐
    +│ name   │ available │
    +├────────┼───────────┤
    +│ InfBus │ true      │
    +└────────┴───────────┘
    julia> show_components(sys, ThermalStandard)ThermalStandard
    +┌─────────────────┬───────────┐
    +│ name            │ available │
    +├─────────────────┼───────────┤
    +│ generator-102-1 │ true      │
    +│ generator-103-1 │ true      │
    +└─────────────────┴───────────┘

    By exploring those it can be seen that the generators are named as: generator-bus_number-id. Then, the generator attached at bus 2 is named generator-102-1.

    Dynamic Injections

    We are now interested in attaching to the system the dynamic component that will be modeling our dynamic generator.

    Dynamic generator devices are composed by 5 components, namely, machine, shaft, avr, tg and pss. So we will be adding functions to create all of its components and the generator itself:

    julia> # *Machine*
    +       machine_classic() = BaseMachine(
    +           0.0, #R
    +           0.2995, #Xd_p
    +           0.7087, #eq_p
    +       )
    +       
    +       # *Shaft*machine_classic (generic function with 1 method)
    julia> shaft_damping() = SingleMass( + 3.148, #H + 2.0, #D + ) + + # *AVR: No AVR*shaft_damping (generic function with 1 method)
    julia> avr_none() = AVRFixed(0.0) + + # *TG: No TG*avr_none (generic function with 1 method)
    julia> tg_none() = TGFixed(1.0) #efficiency + + # *PSS: No PSS*tg_none (generic function with 1 method)
    julia> pss_none() = PSSFixed(0.0)pss_none (generic function with 1 method)

    The next lines receives a static generator name, and creates a DynamicGenerator based on that specific static generator, with the specific components defined previously. This is a classic machine model without AVR, Turbine Governor and PSS.

    julia> static_gen = get_component(Generator, sys, "generator-102-1")generator-102-1 (ThermalStandard):
    +   name: generator-102-1
    +   available: true
    +   status: true
    +   bus: BUS 2 (ACBus)
    +   active_power: 0.7
    +   reactive_power: 0.0
    +   rating: 3.333526661060325
    +   active_power_limits: (min = 0.0, max = 3.18)
    +   reactive_power_limits: (min = -1.0, max = 1.0)
    +   ramp_limits: (up = 3.18, down = 3.18)
    +   operation_cost: ThreePartCost
    +   base_power: 100.0
    +   time_limits: nothing
    +   must_run: false
    +   prime_mover_type: PrimeMovers.OT = 19
    +   fuel: ThermalFuels.OTHER = 14
    +   services: 0-element Vector{Service}
    +   time_at_status: 10000.0
    +   dynamic_injector: nothing
    +   ext: Dict{String, Any}("z_source" => (r = 0.0, x = 1.0))
    +   time_series_container:
    +   InfrastructureSystems.SystemUnitsSettings:
    +      base_value: 100.0
    +      unit_system: UnitSystem.SYSTEM_BASE = 0
    julia> dyn_gen = DynamicGenerator( + name = get_name(static_gen), + ω_ref = 1.0, + machine = machine_classic(), + shaft = shaft_damping(), + avr = avr_none(), + prime_mover = tg_none(), + pss = pss_none(), + ) +generator-102-1 (DynamicGenerator{BaseMachine, SingleMass, AVRFixed, TGFixed, PSSFixed}): + name: generator-102-1 + ω_ref: 1.0 + machine: BaseMachine + shaft: SingleMass + avr: AVRFixed + prime_mover: TGFixed + pss: PSSFixed + base_power: 100.0 + n_states: 2 + states: [:δ, :ω] + ext: Dict{String, Any}() + internal: InfrastructureSystems.InfrastructureSystemsInternal

    The dynamic generator is added to the system by specifying the dynamic and static generator

    julia> add_component!(sys, dyn_gen, static_gen)

    Then we can serialize our system data to a json file that can be later read as:


    julia> to_json(sys, joinpath(file_dir, "modified_sys.json"), force = true)

    Dynamic Lines case: Data creation

    We will now create a three bus system with one inverter and one generator. In order to do so, we will parse the following ThreebusInverter.raw network:

    julia> threebus_sys = build_system(PSIDSystems, "3 Bus Inverter Base")System
    +┌───────────────────┬─────────────┐
    +│ Property          │ Value       │
    +├───────────────────┼─────────────┤
    +│ Name              │             │
    +│ Description       │             │
    +│ System Units Base │ SYSTEM_BASE │
    +│ Base Power        │ 100.0       │
    +│ Base Frequency    │ 60.0        │
    +│ Num Components    │ 16          │
    +└───────────────────┴─────────────┘
    +
    +Static Components
    +┌─────────────────┬───────┬────────────────────────┬───────────────┐
    +│ Type            │ Count │ Has Static Time Series │ Has Forecasts │
    +├─────────────────┼───────┼────────────────────────┼───────────────┤
    +│ ACBus           │ 3     │ false                  │ false         │
    +│ Arc             │ 3     │ false                  │ false         │
    +│ Area            │ 1     │ false                  │ false         │
    +│ Line            │ 3     │ false                  │ false         │
    +│ LoadZone        │ 1     │ false                  │ false         │
    +│ StandardLoad    │ 3     │ false                  │ false         │
    +│ ThermalStandard │ 2     │ false                  │ false         │
    +└─────────────────┴───────┴────────────────────────┴───────────────┘
    julia> slack_bus = first(get_components(x -> get_bustype(x) == BusTypes.REF, Bus, threebus_sys))ERROR: UndefVarError: `BusTypes` not defined
    julia> inf_source = Source( + name = "InfBus", #name + available = true, #availability + active_power = 0.0, + reactive_power = 0.0, + bus = slack_bus, #bus + R_th = 0.0, #Rth + X_th = 5e-6, #Xth + ) +InfBus (Source): + name: InfBus + available: true + bus: BUS 1 (ACBus) + active_power: 0.0 + reactive_power: 0.0 + R_th: 0.0 + X_th: 5.0e-6 + internal_voltage: 1.0 + internal_angle: 0.0 + dynamic_injector: nothing + services: 0-element Vector{Service} + ext: Dict{String, Any}() + internal: InfrastructureSystems.InfrastructureSystemsInternal
    julia> add_component!(threebus_sys, inf_source)

    We will connect a One-d-one-q machine at bus 102, and a Virtual Synchronous Generator Inverter at bus 103. An inverter is composed by a converter, outer control, inner control, dc source, frequency estimator and a filter.

    Dynamic Inverter definition

    We will create specific functions to create the components of the inverter as follows:

    julia> #Define converter as an AverageConverter
    +       converter_high_power() = AverageConverter(
    +           rated_voltage = 138.0,
    +           rated_current = 100.0
    +           )
    +       
    +       #Define Outer Control as a composition of Virtual Inertia + Reactive Power Droopconverter_high_power (generic function with 1 method)
    julia> outer_control() = OuterControl( + VirtualInertia(Ta = 2.0, kd = 400.0, kω = 20.0), + ReactivePowerDroop(kq = 0.2, ωf = 1000.0), + ) + + #Define an Inner Control as a Voltage+Current Controler with Virtual Impedance:outer_control (generic function with 1 method)
    julia> inner_control() = VoltageModeControl( + kpv = 0.59, #Voltage controller proportional gain + kiv = 736.0, #Voltage controller integral gain + kffv = 0.0, #Binary variable enabling voltage feed-forward in current controllers + rv = 0.0, #Virtual resistance in pu + lv = 0.2, #Virtual inductance in pu + kpc = 1.27, #Current controller proportional gain + kic = 14.3, #Current controller integral gain + kffi = 0.0, #Binary variable enabling the current feed-forward in output of current controllers + ωad = 50.0, #Active damping low pass filter cut-off frequency + kad = 0.2, #Active damping gain + ) + + #Define DC Source as a FixedSource:inner_control (generic function with 1 method)
    julia> dc_source_lv() = FixedDCSource(voltage = 600.0) + + #Define a Frequency Estimator as a PLL + #based on Vikram Kaura and Vladimir Blaskoc 1997 paper:dc_source_lv (generic function with 1 method)
    julia> pll() = KauraPLL( + ω_lp = 500.0, #Cut-off frequency for LowPass filter of PLL filter. + kp_pll = 0.084, #PLL proportional gain + ki_pll = 4.69, #PLL integral gain + ) + + #Define an LCL filter:pll (generic function with 1 method)
    julia> filt() = LCLFilter(lf = 0.08, rf = 0.003, cf = 0.074, lg = 0.2, rg = 0.01)filt (generic function with 1 method)

    We will construct the inverter later by specifying to which static device is assigned.

    Dynamic Generator definition

    Similarly we will construct a dynamic generator as follows:

    julia> # Create the machine
    +       machine_oneDoneQ() = OneDOneQMachine(
    +           0.0, #R
    +           1.3125, #Xd
    +           1.2578, #Xq
    +           0.1813, #Xd_p
    +           0.25, #Xq_p
    +           5.89, #Td0_p
    +           0.6, #Tq0_p
    +       )
    +       
    +       # Shaftmachine_oneDoneQ (generic function with 1 method)
    julia> shaft_no_damping() = SingleMass( + 3.01, #H (M = 6.02 -> H = M/2) + 0.0, #D + ) + + # AVR: Type I: Resembles a DC1 AVRshaft_no_damping (generic function with 1 method)
    julia> avr_type1() = AVRTypeI( + 20.0, #Ka - Gain + 0.01, #Ke + 0.063, #Kf + 0.2, #Ta + 0.314, #Te + 0.35, #Tf + 0.001, #Tr + (min = -5.0, max = 5.0), + 0.0039, #Ae - 1st ceiling coefficient + 1.555, #Be - 2nd ceiling coefficient + ) + + #No TGavr_type1 (generic function with 1 method)
    julia> tg_none() = TGFixed(1.0) #efficiency + + #No PSStg_none (generic function with 1 method)
    julia> pss_none() = PSSFixed(0.0) #Vspss_none (generic function with 1 method)

    Now we will construct the dynamic generator and inverter.

    Add the components to the system

    julia> for g in get_components(Generator, threebus_sys)
    +           #Find the generator at bus 102
    +           if get_number(get_bus(g)) == 102
    +               #Create the dynamic generator
    +               case_gen = DynamicGenerator(
    +                   get_name(g),
    +                   1.0, # ω_ref,
    +                   machine_oneDoneQ(), #machine
    +                   shaft_no_damping(), #shaft
    +                   avr_type1(), #avr
    +                   tg_none(), #tg
    +                   pss_none(), #pss
    +               )
    +               #Attach the dynamic generator to the system by
    +               # specifying the dynamic and static components
    +               add_component!(threebus_sys, case_gen, g)
    +               #Find the generator at bus 103
    +           elseif get_number(get_bus(g)) == 103
    +               #Create the dynamic inverter
    +               case_inv = DynamicInverter(
    +                   get_name(g),
    +                   1.0, # ω_ref,
    +                   converter_high_power(), #converter
    +                   outer_control(), #outer control
    +                   inner_control(), #inner control voltage source
    +                   dc_source_lv(), #dc source
    +                   pll(), #pll
    +                   filt(), #filter
    +               )
    +               #Attach the dynamic inverter to the system
    +               add_component!(threebus_sys, case_inv, g)
    +           end
    +       end

    Save the system in a JSON file


    julia> to_json(threebus_sys, joinpath(file_dir, "threebus_sys.json"), force = true)
    diff --git a/previews/PR360/tutorials/tutorial_dynamic_lines/index.html b/previews/PR360/tutorials/tutorial_dynamic_lines/index.html new file mode 100644 index 000000000..c261ee7bb --- /dev/null +++ b/previews/PR360/tutorials/tutorial_dynamic_lines/index.html @@ -0,0 +1,297 @@ + +Dynamic Lines Simulation · PowerSimulationsDynamics.jl

    Line Modeling Simulations

    Originally Contributed by: Rodrigo Henriquez-Auba and José Daniel Lara

    Introduction

    This tutorial will introduce an example of considering dynamic lines in PowerSimulationsDynamics.

    This tutorial presents a simulation of a three-bus system, with an infinite bus (represented as a voltage source behind an impedance) at bus 1, a one d- one q- machine on bus 2 and an inverter of 19 states, as a virtual synchronous machine at bus 3. The perturbation will be the trip of two of the three circuits (triplicating its resistance and impedance) of the line that connects bus 1 and bus 3. This case also consider a dynamic line model for connection between buses 2 and 3. We will compare it against a system without dynamic lines.

    It is recommended to check the OMIB tutorial first, since that includes more details and explanations on all definitions and functions.

    Step 1: Package Initialization

    julia> using PowerSimulationsDynamics
    julia> using PowerSystems
    julia> using PowerNetworkMatrices
    julia> using PowerSystemCaseBuilder
    julia> using Sundials
    julia> using Plots
    Note

    PowerSystemCaseBuilder.jl is a helper library that makes it easier to reproduce examples in the documentation and tutorials. Normally you would pass your local files to create the system data instead of calling the function build_system. For more details visit PowerSystemCaseBuilder Documentation

    Step 2: Data creation

    Load the system using PowerSystemCaseBuilder.jl:

    julia> threebus_sys = build_system(PSIDSystems, "Three Bus Dynamic data Example System")System
    +┌───────────────────┬─────────────┐
    +│ Property          │ Value       │
    +├───────────────────┼─────────────┤
    +│ Name              │             │
    +│ Description       │             │
    +│ System Units Base │ SYSTEM_BASE │
    +│ Base Power        │ 100.0       │
    +│ Base Frequency    │ 60.0        │
    +│ Num Components    │ 19          │
    +└───────────────────┴─────────────┘
    +
    +Static Components
    +┌─────────────────┬───────┬────────────────────────┬───────────────┐
    +│ Type            │ Count │ Has Static Time Series │ Has Forecasts │
    +├─────────────────┼───────┼────────────────────────┼───────────────┤
    +│ ACBus           │ 3     │ false                  │ false         │
    +│ Arc             │ 3     │ false                  │ false         │
    +│ Area            │ 1     │ false                  │ false         │
    +│ Line            │ 3     │ false                  │ false         │
    +│ LoadZone        │ 1     │ false                  │ false         │
    +│ Source          │ 1     │ false                  │ false         │
    +│ StandardLoad    │ 3     │ false                  │ false         │
    +│ ThermalStandard │ 2     │ false                  │ false         │
    +└─────────────────┴───────┴────────────────────────┴───────────────┘
    +
    +Dynamic Components
    +┌──────────────────┬───────┐
    +│ Type             │ Count │
    +├──────────────────┼───────┤
    +│ DynamicGenerator │ 1     │
    +│ DynamicInverter  │ 1     │
    +└──────────────────┴───────┘

    In addition, we will create a new copy of the system on which we will simulate the same case, but will consider dynamic lines:

    julia> threebus_sys_dyn = deepcopy(threebus_sys);

    Step 3: Create the fault and simulation on the Static Lines system

    First, we construct the perturbation, by properly computing the new Ybus on the system:

    julia> #Make a copy of the original system
    +       sys2 = deepcopy(threebus_sys)
    +       #Triplicates the impedance of the line named "BUS 1-BUS 3-i_1"System
    +┌───────────────────┬─────────────┐
    +│ Property          │ Value       │
    +├───────────────────┼─────────────┤
    +│ Name              │             │
    +│ Description       │             │
    +│ System Units Base │ SYSTEM_BASE │
    +│ Base Power        │ 100.0       │
    +│ Base Frequency    │ 60.0        │
    +│ Num Components    │ 19          │
    +└───────────────────┴─────────────┘
    +
    +Static Components
    +┌─────────────────┬───────┬────────────────────────┬───────────────┐
    +│ Type            │ Count │ Has Static Time Series │ Has Forecasts │
    +├─────────────────┼───────┼────────────────────────┼───────────────┤
    +│ ACBus           │ 3     │ false                  │ false         │
    +│ Arc             │ 3     │ false                  │ false         │
    +│ Area            │ 1     │ false                  │ false         │
    +│ Line            │ 3     │ false                  │ false         │
    +│ LoadZone        │ 1     │ false                  │ false         │
    +│ Source          │ 1     │ false                  │ false         │
    +│ StandardLoad    │ 3     │ false                  │ false         │
    +│ ThermalStandard │ 2     │ false                  │ false         │
    +└─────────────────┴───────┴────────────────────────┴───────────────┘
    +
    +Dynamic Components
    +┌──────────────────┬───────┐
    +│ Type             │ Count │
    +├──────────────────┼───────┤
    +│ DynamicGenerator │ 1     │
    +│ DynamicInverter  │ 1     │
    +└──────────────────┴───────┘
    julia> fault_branches = get_components(ACBranch, sys2)ACBranch Counts: +Line: 3
    julia> for br in fault_branches + if get_name(br) == "BUS 1-BUS 3-i_1" + br.r = 3 * br.r + br.x = 3 * br.x + b_new = (from = br.b.from / 3, to = br.b.to / 3) + br.b = b_new + end + end + #Obtain the new Ybus
    julia> Ybus_fault = Ybus(sys2).data + #Define Fault: Change of YBus3×3 SparseArrays.SparseMatrixCSC{ComplexF64, Int64} with 9 stored entries: + 0.91954-10.9011im -0.689655+8.27586im -0.229885+2.75862im + -0.689655+8.27586im 0.714334-8.78642im -0.0246792+1.11056im + -0.229885+2.75862im -0.0246792+1.11056im 0.254564-3.33585im
    julia> Ybus_change = NetworkSwitch( + 1.0, #change at t = 1.0 + Ybus_fault, #New YBus + );

    Now, we construct the simulation:

    julia> #Time span of our simulation
    +       tspan = (0.0, 30.0)
    +       
    +       #Define Simulation(0.0, 30.0)
    julia> sim = Simulation( + ResidualModel, #Type of model used + threebus_sys, #system + pwd(), #folder to output results + tspan, #time span + Ybus_change, #Type of perturbation + )Simulation Summary +┌─────────────────────────┬────────────────┐ +│ Property │ Value │ +├─────────────────────────┼────────────────┤ +│ Status │ BUILT │ +│ Simulation Type │ Residual Model │ +│ Initialized? │ Yes │ +│ Multimachine system? │ No │ +│ Time Span │ (0.0, 30.0) │ +│ Number of States │ 33 │ +│ Number of Perturbations │ 1 │ +└─────────────────────────┴────────────────┘

    We can obtain the initial conditions as:

    julia> #Print the initial states. It also give the symbols used to describe those states.
    +       show_states_initial_value(sim)Voltage Variables
    +====================
    +BUS 1
    +====================
    +Vm 1.02
    +θ 0.0
    +====================
    +BUS 2
    +====================
    +Vm 1.0142
    +θ -0.0247
    +====================
    +BUS 3
    +====================
    +Vm 1.0059
    +θ 0.05
    +====================
    +====================
    +Differential States
    +generator-102-1
    +====================
    +eq_p 0.6478
    +ed_p 0.6672
    +δ 0.9386
    +ω 1.0
    +Vf 1.0781
    +Vr1 0.0333
    +Vr2 -0.1941
    +Vm 1.0142
    +====================
    +Differential States
    +generator-103-1
    +====================
    +θ_oc 0.4573
    +ω_oc 1.0
    +q_oc -0.4453
    +ξd_ic 0.0013
    +ξq_ic 0.0004
    +γd_ic 0.0615
    +γq_ic -0.0138
    +ϕd_ic 0.8765
    +ϕq_ic -0.1978
    +vd_pll 0.8986
    +vq_pll 0.0
    +ε_pll 0.0
    +θ_pll 0.2354
    +ir_cnv 0.7462
    +ii_cnv 0.757
    +vr_filter 0.8738
    +vi_filter 0.2095
    +ir_filter 0.7617
    +ii_filter 0.6923
    +====================

    Step 4: Run the simulation of the Static Lines System

    julia> #Run the simulation
    +       execute!(
    +           sim, #simulation structure
    +           IDA(), #Sundials DAE Solver
    +           dtmax = 0.02, #Maximum step size
    +       )SIMULATION_FINALIZED::BUILD_STATUS = 6

    Step 5: Store the solution

    julia> results = read_results(sim)Simulation Results Summary
    +┌────────────────────────────┬─────────────┐
    +│ Property                   │ Value       │
    +├────────────────────────────┼─────────────┤
    +│ System Base Power [MVA]    │ 100.0       │
    +│ System Base Frequency [Hz] │ 60.0        │
    +│ Time Span                  │ (0.0, 30.0) │
    +│ Total Time Steps           │ 1607        │
    +│ Number of States           │ 33          │
    +│ Total solve time           │ 2.986517575 │
    +└────────────────────────────┴─────────────┘
    julia> series2 = get_voltage_magnitude_series(results, 102)([0.0, 0.001, 0.002, 0.004, 0.008, 0.016, 0.032, 0.052000000000000005, 0.07200000000000001, 0.09200000000000001 … 29.83954153464911, 29.85954153464911, 29.87954153464911, 29.89954153464911, 29.91954153464911, 29.93954153464911, 29.95954153464911, 29.97954153464911, 29.999541534649108, 30.0], [1.0142000000000002, 1.0142000000001268, 1.0142000000001326, 1.0142000000001927, 1.01420000000014, 1.014200000000125, 1.0142000000001052, 1.0142000000000875, 1.014200000000071, 1.0142000000000564 … 1.0140816770731866, 1.0140823112693007, 1.014082942782033, 1.0140835715610201, 1.014084197556437, 1.0140848207190878, 1.0140854410003357, 1.0140860583521254, 1.0140866727269917, 1.0140866867751974])
    julia> zoom = [ + (series2[1][ix], series2[2][ix]) for + (ix, s) in enumerate(series2[1]) if (s > 0.90 && s < 1.6) + ];

    Step 3.1: Create the fault and simulation on the Dynamic Lines system

    An important aspect to consider is that DynamicLines must not be considered in the computation of the Ybus. First we construct the Dynamic Line, by finding the Line named "BUS 2-BUS 3-i_1", and then adding it to the system.

    julia> # get component return the Branch on threebus_sys_dyn named "BUS 2-BUS 3-i_1"
    +       dyn_branch = DynamicBranch(get_component(Line, threebus_sys_dyn,"BUS 2-BUS 3-i_1"))
    +       # Adding a dynamic line will immediately remove the static line from the system.
    +BUS 2-BUS 3-i_1 (DynamicBranch):
    +   branch: BUS 2-BUS 3-i_1 (Line)
    +   n_states: 2
    +   states: [:Il_R, :Il_I]
    +   internal: InfrastructureSystems.InfrastructureSystemsInternal
    julia> add_component!(threebus_sys_dyn, dyn_branch)

    Similarly, we construct the Ybus fault by creating a copy of the original system, but removing the Line "BUS 2-BUS 3-i_1" to avoid considering it in the Ybus:

    julia> #Make a copy of the original system
    +       sys3 = deepcopy(threebus_sys);
    +       #Remove Line "BUS 2-BUS 3-i_1"
    julia> remove_component!(Line, sys3, "BUS 2-BUS 3-i_1") + #Triplicates the impedance of the line named "BUS 1-BUS 2-i_1"
    julia> fault_branches2 = get_components(Line, sys3)Line Counts: +Line: 2
    julia> for br in fault_branches2 + if get_name(br) == "BUS 1-BUS 3-i_1" + br.r = 3 * br.r + br.x = 3 * br.x + b_new = (from = br.b.from / 3, to = br.b.to / 3) + br.b = b_new + end + end + #Obtain the new Ybus
    julia> Ybus_fault_dyn = Ybus(sys3).data + #Define Fault: Change of YBus3×3 SparseArrays.SparseMatrixCSC{ComplexF64, Int64} with 7 stored entries: + 0.91954-10.9011im -0.689655+8.27586im -0.229885+2.75862im + -0.689655+8.27586im 0.689655-8.17586im ⋅ + -0.229885+2.75862im ⋅ 0.229885-2.72529im
    julia> Ybus_change_dyn = NetworkSwitch( + 1.0, #change at t = 1.0 + Ybus_fault_dyn, #New YBus + )NetworkSwitch(1.0, sparse([1, 2, 3, 4, 5, 6, 1, 2, 4, 5 … 5, 6, 1, 2, 4, 5, 1, 3, 4, 6], [1, 1, 1, 1, 1, 1, 2, 2, 2, 2 … 4, 4, 5, 5, 5, 5, 6, 6, 6, 6], [0.9195402298850576, -0.6896551724137931, -0.2298850574712644, 10.901149425287358, -8.275862068965518, -2.7586206896551726, -0.6896551724137931, 0.6896551724137931, -8.275862068965518, 8.175862068965518 … -0.6896551724137931, -0.2298850574712644, 8.275862068965518, -8.175862068965518, -0.6896551724137931, 0.6896551724137931, 2.7586206896551726, -2.7252873563218394, -0.2298850574712644, 0.2298850574712644], 6, 6))

    Step 4.1: Run the simulation of the Dynamic Lines System

    Now, we construct the simulation:

    julia> # Define Simulation
    +       sim_dyn = Simulation(
    +           ResidualModel, #Type of model used
    +           threebus_sys_dyn, #system
    +           pwd(), #folder to output results
    +           (0.0, 30.0), #time span
    +           Ybus_change_dyn, #Type of perturbation
    +       )Simulation Summary
    +┌─────────────────────────┬────────────────┐
    +│ Property                │ Value          │
    +├─────────────────────────┼────────────────┤
    +│ Status                  │ BUILT          │
    +│ Simulation Type         │ Residual Model │
    +│ Initialized?            │ Yes            │
    +│ Multimachine system?    │ No             │
    +│ Time Span               │ (0.0, 30.0)    │
    +│ Number of States        │ 35             │
    +│ Number of Perturbations │ 1              │
    +└─────────────────────────┴────────────────┘
    julia> # Run the simulation
    +       execute!(
    +           sim_dyn, #simulation structure
    +           IDA(), #Sundials DAE Solver
    +           dtmax = 0.02, #Maximum step size
    +       )SIMULATION_FINALIZED::BUILD_STATUS = 6

    We can obtain the initial conditions as:

    julia> #Print the initial states. It also give the symbols used to describe those states.
    +       show_states_initial_value(sim_dyn)Voltage Variables
    +====================
    +BUS 1
    +====================
    +Vm 1.02
    +θ 0.0
    +====================
    +BUS 2
    +====================
    +Vm 1.0141
    +θ -0.0155
    +====================
    +BUS 3
    +====================
    +Vm 0.9686
    +θ 0.1354
    +====================
    +====================
    +Differential States
    +generator-102-1
    +====================
    +eq_p 0.681
    +ed_p 0.6477
    +δ 0.907
    +ω 1.0
    +Vf 1.1115
    +Vr1 0.0355
    +Vr2 -0.2001
    +Vm 1.0141
    +====================
    +Differential States
    +generator-103-1
    +====================
    +θ_oc 0.5658
    +ω_oc 1.0
    +q_oc -0.3799
    +ξd_ic 0.0014
    +ξq_ic 0.0003
    +γd_ic 0.0595
    +γq_ic -0.014
    +ϕd_ic 0.8484
    +ϕq_ic -0.201
    +vd_pll 0.8719
    +vq_pll 0.0
    +ε_pll -0.0
    +θ_pll 0.3332
    +ir_cnv 0.715
    +ii_cnv 0.7768
    +vr_filter 0.824
    +vi_filter 0.2851
    +ir_filter 0.7361
    +ii_filter 0.7158
    +====================
    +====================
    +Line Current States
    +====================
    +Line BUS 2-BUS 3-i_1
    +Il_R -0.16141
    +Il_I -0.06381
    +====================

    Step 5.1: Store the solution

    julia> results_dyn = read_results(sim_dyn)Simulation Results Summary
    +┌────────────────────────────┬─────────────┐
    +│ Property                   │ Value       │
    +├────────────────────────────┼─────────────┤
    +│ System Base Power [MVA]    │ 100.0       │
    +│ System Base Frequency [Hz] │ 60.0        │
    +│ Time Span                  │ (0.0, 30.0) │
    +│ Total Time Steps           │ 1721        │
    +│ Number of States           │ 35          │
    +│ Total solve time           │ 2.424997249 │
    +└────────────────────────────┴─────────────┘
    julia> series2_dyn = get_voltage_magnitude_series(results_dyn, 102);
    julia> zoom_dyn = [ + (series2_dyn[1][ix], series2_dyn[2][ix]) for + (ix, s) in enumerate(series2_dyn[1]) if (s > 0.90 && s < 1.6) + ];

    Step 6.1: Compare the solutions:

    We can observe the effect of Dynamic Lines

    julia> plot(series2_dyn, label = "V_gen_dyn");
    julia> plot!(series2, label = "V_gen_st", xlabel = "Time [s]", ylabel = "Voltage [pu]");

    plot

    that looks quite similar. The differences can be observed in the zoom plot:

    julia> plot(zoom_dyn, label = "V_gen_dyn");
    julia> plot!(zoom, label = "V_gen_st", xlabel = "Time [s]", ylabel = "Voltage [pu]");

    plot

    diff --git a/previews/PR360/tutorials/tutorial_inverter_modeling/index.html b/previews/PR360/tutorials/tutorial_inverter_modeling/index.html new file mode 100644 index 000000000..0f4235acc --- /dev/null +++ b/previews/PR360/tutorials/tutorial_inverter_modeling/index.html @@ -0,0 +1,617 @@ + +Inverter Modeling · PowerSimulationsDynamics.jl

    Inverter Modeling simulation

    Originally Contributed by: José Daniel Lara

    Introduction

    This tutorial will introduce the modeling of an inverter with Virtual Inertia in a multi-machine model of the system. We will load the data directly from PSS/e dynamic files.

    The tutorial uses a modified 14-bus system on which all the synchronous machines have been substituted by generators with ESAC1A AVR's and no Turbine Governors.

    In the first portion of the tutorial we will simulate the system with the original data and cause a line trip between Buses 2 and 4. In the second part of the simulation, we will switch generator 6 with a battery using an inverter and perform the same fault.

    Load the packages

    julia> using PowerSimulationsDynamics
    julia> using PowerSystemCaseBuilder
    julia> using PowerSystems
    julia> const PSY = PowerSystemsPowerSystems
    julia> using PowerFlows
    julia> using Logging
    julia> using Sundials
    julia> using Plots
    Note

    PowerSystemCaseBuilder.jl is a helper library that makes it easier to reproduce examples in the documentation and tutorials. Normally you would pass your local files to create the system data instead of calling the function build_system. For more details visit PowerSystemCaseBuilder Documentation

    Create the system using PowerSystemCaseBuilder.jl:

    julia> sys = build_system(PSIDSystems, "14 Bus Base Case")System
    +┌───────────────────┬─────────────┐
    +│ Property          │ Value       │
    +├───────────────────┼─────────────┤
    +│ Name              │             │
    +│ Description       │             │
    +│ System Units Base │ SYSTEM_BASE │
    +│ Base Power        │ 100.0       │
    +│ Base Frequency    │ 60.0        │
    +│ Num Components    │ 77          │
    +└───────────────────┴─────────────┘
    +
    +Static Components
    +┌─────────────────┬───────┬────────────────────────┬───────────────┐
    +│ Type            │ Count │ Has Static Time Series │ Has Forecasts │
    +├─────────────────┼───────┼────────────────────────┼───────────────┤
    +│ ACBus           │ 14    │ false                  │ false         │
    +│ Arc             │ 20    │ false                  │ false         │
    +│ Area            │ 1     │ false                  │ false         │
    +│ Line            │ 16    │ false                  │ false         │
    +│ LoadZone        │ 1     │ false                  │ false         │
    +│ StandardLoad    │ 11    │ false                  │ false         │
    +│ TapTransformer  │ 3     │ false                  │ false         │
    +│ ThermalStandard │ 5     │ false                  │ false         │
    +│ Transformer2W   │ 1     │ false                  │ false         │
    +└─────────────────┴───────┴────────────────────────┴───────────────┘
    +
    +Dynamic Components
    +┌──────────────────┬───────┐
    +│ Type             │ Count │
    +├──────────────────┼───────┤
    +│ DynamicGenerator │ 4     │
    +│ DynamicGenerator │ 1     │
    +└──────────────────┴───────┘

    PowerSystemCaseBuilder.jl is a helper library that makes it easier to reproduce examples in the documentation and tutorials. Normally you would pass your local files to create the system data.

    Define Simulation Problem with a 20 second simulation period and the branch trip at t = 1.0:

    julia> sim = Simulation(
    +           ResidualModel, #Type of model used
    +           sys,         #system
    +           mktempdir(),       #path for the simulation output
    +           (0.0, 20.0), #time span
    +           BranchTrip(1.0, Line, "BUS 02-BUS 04-i_1");
    +           console_level = Logging.Info,
    +       )Iter     f(x) inf-norm    Step 2-norm 
    +------   --------------   --------------
    +Simulation Summary
    +┌─────────────────────────┬────────────────┐
    +│ Property                │ Value          │
    +├─────────────────────────┼────────────────┤
    +│ Status                  │ BUILT          │
    +│ Simulation Type         │ Residual Model │
    +│ Initialized?            │ Yes            │
    +│ Multimachine system?    │ Yes            │
    +│ Time Span               │ (0.0, 20.0)    │
    +│ Number of States        │ 86             │
    +│ Number of Perturbations │ 1              │
    +└─────────────────────────┴────────────────┘

    Now that the system is initialized, we can verify the system states for potential issues.

    julia> show_states_initial_value(sim)Voltage Variables
    +====================
    +BUS 01
    +====================
    +Vm 1.06
    +θ 0.0
    +====================
    +BUS 02
    +====================
    +Vm 1.04
    +θ -0.0711
    +====================
    +BUS 03
    +====================
    +Vm 1.01
    +θ -0.1787
    +====================
    +BUS 04
    +====================
    +Vm 1.0129
    +θ -0.1458
    +====================
    +BUS 05
    +====================
    +Vm 1.0165
    +θ -0.1235
    +====================
    +BUS 06
    +====================
    +Vm 1.06
    +θ -0.1949
    +====================
    +BUS 07
    +====================
    +Vm 1.0438
    +θ -0.1812
    +====================
    +BUS 08
    +====================
    +Vm 1.08
    +θ -0.1656
    +====================
    +BUS 09
    +====================
    +Vm 1.0263
    +θ -0.2102
    +====================
    +BUS 10
    +====================
    +Vm 1.0245
    +θ -0.2125
    +====================
    +BUS 11
    +====================
    +Vm 1.0384
    +θ -0.2059
    +====================
    +BUS 12
    +====================
    +Vm 1.0436
    +θ -0.2105
    +====================
    +BUS 13
    +====================
    +Vm 1.0372
    +θ -0.2119
    +====================
    +BUS 14
    +====================
    +Vm 1.0126
    +θ -0.2291
    +====================
    +====================
    +Differential States
    +generator-3-1
    +====================
    +eq_p 1.0649
    +ed_p 0.1243
    +ψ_kd 0.9872
    +ψ_kq 0.2132
    +δ 0.034
    +ω 1.0
    +Vm 1.01
    +Vr1 0.006
    +Vr2 2.419
    +Ve 1.791
    +Vr3 -0.0726
    +====================
    +Differential States
    +generator-8-1
    +====================
    +eq_p 1.2657
    +ed_p 0.0462
    +ψ_kd 1.1584
    +ψ_kq 0.1748
    +δ 0.019
    +ω 1.0
    +Vm 1.08
    +Vr1 0.0097
    +Vr2 3.9162
    +Ve 2.8839
    +Vr3 -0.1175
    +====================
    +Differential States
    +generator-1-1
    +====================
    +eq_p 1.0604
    +ed_p -0.0111
    +ψ_kd 1.0563
    +ψ_kq 0.1134
    +δ 0.1684
    +ω 1.0
    +Vm 1.06
    +Vr1 0.0049
    +Vr2 1.951
    +Ve 1.4049
    +Vr3 -0.0585
    +x_g1 0.3144
    +x_g2 0.3144
    +x_g3 0.3144
    +====================
    +Differential States
    +generator-2-1
    +====================
    +eq_p 1.1038
    +ed_p 0.1491
    +ψ_kd 1.003
    +ψ_kq 0.2748
    +δ 0.1963
    +ω 1.0
    +Vm 1.04
    +Vr1 0.0071
    +Vr2 2.8613
    +Ve 2.1338
    +Vr3 -0.0858
    +====================
    +Differential States
    +generator-6-1
    +====================
    +eq_p 1.167
    +ed_p 0.0955
    +ψ_kd 1.08
    +ψ_kq 0.3084
    +δ 0.1387
    +ω 1.0
    +Vm 1.06
    +Vr1 0.0082
    +Vr2 3.2875
    +Ve 2.4472
    +Vr3 -0.0986
    +====================

    We execute the simulation with an additional tolerance for the solver set at 1e-8:

    julia> execute!(sim, IDA(); abstol = 1e-8)SIMULATION_FINALIZED::BUILD_STATUS = 6

    Using PowerSimulationsDynamics tools for exploring the results, we can plot all the voltage results for the buses:

    julia> result = read_results(sim)Simulation Results Summary
    +┌────────────────────────────┬─────────────┐
    +│ Property                   │ Value       │
    +├────────────────────────────┼─────────────┤
    +│ System Base Power [MVA]    │ 100.0       │
    +│ System Base Frequency [Hz] │ 60.0        │
    +│ Time Span                  │ (0.0, 20.0) │
    +│ Total Time Steps           │ 342         │
    +│ Number of States           │ 86          │
    +│ Total solve time           │ 2.254391124 │
    +└────────────────────────────┴─────────────┘
    julia> p = plot();
    julia> for b in get_components(ACBus, sys) + voltage_series = get_voltage_magnitude_series(result, get_number(b)) + plot!( + p, + voltage_series; + xlabel = "Time", + ylabel = "Voltage Magnitude [pu]", + label = "Bus - $(get_name(b))", + ); + end

    plot

    We can also explore the frequency of the different generators

    julia> p2 = plot();
    julia> for g in get_components(ThermalStandard, sys) + state_series = get_state_series(result, (get_name(g), :ω)) + plot!( + p2, + state_series; + xlabel = "Time", + ylabel = "Speed [pu]", + label = "$(get_name(g)) - ω", + ); + end

    plot

    It is also possible to explore the small signal stability of this system we created.

    julia> res = small_signal_analysis(sim)The system is small signal stable

    The eigenvalues can be explored

    julia> res.eigenvalues58-element Vector{ComplexF64}:
    +  -1000.0000000000009 + 0.0im
    +  -1000.0000000000006 + 0.0im
    +  -1000.0000000000005 + 0.0im
    +  -1000.0000000000002 + 0.0im
    +   -999.9999999999994 + 0.0im
    +    -51.8336437195576 + 0.0im
    +   -51.70455018825636 + 0.0im
    +   -51.44437441320372 - 0.018220782843113438im
    +   -51.44437441320372 + 0.018220782843113438im
    +   -51.41020350332119 + 0.0im
    +                      ⋮
    +  -0.8293800767696595 - 0.04428569213206042im
    +  -0.8293800767696595 + 0.04428569213206042im
    +  -0.6362034818550809 + 0.0im
    +                 -0.5 + 0.0im
    +  -0.4682884182384499 + 0.0im
    + -0.28233919601444385 + 0.0im
    +  -0.2291061939257908 - 7.684635708748412im
    +  -0.2291061939257908 + 7.684635708748412im
    +                  0.0 + 0.0im

    Modifying the system and adding storage

    Reload the system for this example:

    julia> sys = build_system(PSIDSystems, "14 Bus Base Case")
    +       
    +       # We want to remove the generator 6 and the dynamic component attached to it.System
    +┌───────────────────┬─────────────┐
    +│ Property          │ Value       │
    +├───────────────────┼─────────────┤
    +│ Name              │             │
    +│ Description       │             │
    +│ System Units Base │ SYSTEM_BASE │
    +│ Base Power        │ 100.0       │
    +│ Base Frequency    │ 60.0        │
    +│ Num Components    │ 77          │
    +└───────────────────┴─────────────┘
    +
    +Static Components
    +┌─────────────────┬───────┬────────────────────────┬───────────────┐
    +│ Type            │ Count │ Has Static Time Series │ Has Forecasts │
    +├─────────────────┼───────┼────────────────────────┼───────────────┤
    +│ ACBus           │ 14    │ false                  │ false         │
    +│ Arc             │ 20    │ false                  │ false         │
    +│ Area            │ 1     │ false                  │ false         │
    +│ Line            │ 16    │ false                  │ false         │
    +│ LoadZone        │ 1     │ false                  │ false         │
    +│ StandardLoad    │ 11    │ false                  │ false         │
    +│ TapTransformer  │ 3     │ false                  │ false         │
    +│ ThermalStandard │ 5     │ false                  │ false         │
    +│ Transformer2W   │ 1     │ false                  │ false         │
    +└─────────────────┴───────┴────────────────────────┴───────────────┘
    +
    +Dynamic Components
    +┌──────────────────┬───────┐
    +│ Type             │ Count │
    +├──────────────────┼───────┤
    +│ DynamicGenerator │ 4     │
    +│ DynamicGenerator │ 1     │
    +└──────────────────┴───────┘
    julia> thermal_gen = get_component(ThermalStandard, sys, "generator-6-1")generator-6-1 (ThermalStandard): + name: generator-6-1 + available: true + status: true + bus: BUS 06 (ACBus) + active_power: 0.15 + reactive_power: 0.14800000000000002 + rating: 99.99028802838804 + active_power_limits: (min = -99.99, max = 99.99) + reactive_power_limits: (min = -0.06, max = 0.24) + ramp_limits: (up = 24.9975, down = 24.9975) + operation_cost: ThreePartCost + base_power: 25.0 + time_limits: nothing + must_run: false + prime_mover_type: PrimeMovers.OT = 19 + fuel: ThermalFuels.OTHER = 14 + services: 0-element Vector{Service} + time_at_status: 10000.0 + dynamic_injector: generator-6-1 (DynamicGenerator{RoundRotorQuadratic, SingleMass, ESAC1A, TGFixed, PSSFixed}) + ext: Dict{String, Any}("z_source" => Dict{String, Any}("x" => 0.12, "r" => 0)) + time_series_container: + InfrastructureSystems.SystemUnitsSettings: + base_value: 100.0 + unit_system: UnitSystem.SYSTEM_BASE = 0
    julia> remove_component!(sys, get_dynamic_injector(thermal_gen))
    julia> remove_component!(sys, thermal_gen) + + # We can now define our storage device and add it to the system
    julia> storage = GenericBattery( + name = "Battery", + bus = get_component(Bus, sys, "BUS 06"), + available = true, + prime_mover = PrimeMovers.BA, + active_power = 0.6, + reactive_power = 0.16, + rating = 1.1, + base_power = 25.0, + initial_energy = 50.0, + state_of_charge_limits = (min = 5.0, max = 100.0), + input_active_power_limits = (min = 0.0, max = 1.0), + output_active_power_limits = (min = 0.0, max = 1.0), + reactive_power_limits = (min = -1.0, max = 1.0), + efficiency = (in = 0.80, out = 0.90), + )ERROR: UndefKeywordError: keyword argument `prime_mover_type` not assigned
    julia> add_component!(sys, storage)ERROR: UndefVarError: `storage` not defined

    A good sanity check it running a power flow on the system to make sure all the components are properly scaled and that the system is properly balanced. We can use PowerSystems to perform this check. We can get the results back and perform a sanity check.

    julia> res = solve_powerflow(ACPowerFlow(), sys)Dict{String, DataFrames.DataFrame} with 2 entries:
    +  "flow_results" => 20×9 DataFrame…
    +  "bus_results"  => 14×9 DataFrame…
    julia> res["bus_results"]14×9 DataFrame + Row │ bus_number Vm θ P_gen P_load P_net Q_gen ⋯ + │ Int64 Float64 Float64 Float64 Float64 Float64 Float64 ⋯ +─────┼────────────────────────────────────────────────────────────────────────── + 1 │ 1 1.06 0.0 209.537 0.0 209.537 -0.974255 ⋯ + 2 │ 2 1.04 -0.0770544 30.0 21.7 8.3 31.1788 + 3 │ 3 1.01 -0.188366 20.0 94.2 -74.2 22.6545 + 4 │ 4 1.01107 -0.158262 0.0 47.8 -47.8 0.0 + 5 │ 5 1.01415 -0.13611 0.0 7.6 -7.6 0.0 ⋯ + 6 │ 6 1.06 -0.230397 0.0 11.2 -11.2 18.3298 + 7 │ 7 1.04369 -0.19934 0.0 0.0 0.0 0.0 + 8 │ 8 1.08 -0.183712 10.0 0.0 10.0 22.3421 + 9 │ 9 1.02727 -0.231347 0.0 29.5 -29.5 0.0 ⋯ + 10 │ 10 1.02551 -0.236217 0.0 9.0 -9.0 0.0 + 11 │ 11 1.03904 -0.235418 0.0 3.5 -3.5 0.0 + 12 │ 12 1.04357 -0.245043 0.0 6.1 -6.1 0.0 + 13 │ 13 1.03753 -0.245351 0.0 13.5 -13.5 0.0 ⋯ + 14 │ 14 1.01337 -0.255634 0.0 14.9 -14.9 0.0 + 2 columns omitted

    After verifying that the system works, we can define our inverter dynamics and add it to the battery that has already been stored in the system.

    julia> inverter = DynamicInverter(
    +           name = get_name(storage),
    +           ω_ref = 1.0, # ω_ref,
    +           converter = AverageConverter(rated_voltage = 138.0, rated_current = 100.0),
    +           outer_control = OuterControl(
    +               VirtualInertia(Ta = 2.0, kd = 400.0, kω = 20.0),
    +               ReactivePowerDroop(kq = 0.2, ωf = 1000.0),
    +           ),
    +           inner_control = VoltageModeControl(
    +               kpv = 0.59,     #Voltage controller proportional gain
    +               kiv = 736.0,    #Voltage controller integral gain
    +               kffv = 0.0,     #Binary variable enabling the voltage feed-forward in output of current controllers
    +               rv = 0.0,       #Virtual resistance in pu
    +               lv = 0.2,       #Virtual inductance in pu
    +               kpc = 1.27,     #Current controller proportional gain
    +               kic = 14.3,     #Current controller integral gain
    +               kffi = 0.0,     #Binary variable enabling the current feed-forward in output of current controllers
    +               ωad = 50.0,     #Active damping low pass filter cut-off frequency
    +               kad = 0.2,
    +           ),
    +           dc_source = FixedDCSource(voltage = 600.0),
    +           freq_estimator = KauraPLL(
    +               ω_lp = 500.0, #Cut-off frequency for LowPass filter of PLL filter.
    +               kp_pll = 0.084,  #PLL proportional gain
    +               ki_pll = 4.69,   #PLL integral gain
    +           ),
    +           filter = LCLFilter(lf = 0.08, rf = 0.003, cf = 0.074, lg = 0.2, rg = 0.01),
    +       )ERROR: UndefVarError: `storage` not defined
    julia> add_component!(sys, inverter, storage)ERROR: UndefVarError: `inverter` not defined

    These are the current system components:

    julia> sysSystem
    +┌───────────────────┬─────────────┐
    +│ Property          │ Value       │
    +├───────────────────┼─────────────┤
    +│ Name              │             │
    +│ Description       │             │
    +│ System Units Base │ SYSTEM_BASE │
    +│ Base Power        │ 100.0       │
    +│ Base Frequency    │ 60.0        │
    +│ Num Components    │ 75          │
    +└───────────────────┴─────────────┘
    +
    +Static Components
    +┌─────────────────┬───────┬────────────────────────┬───────────────┐
    +│ Type            │ Count │ Has Static Time Series │ Has Forecasts │
    +├─────────────────┼───────┼────────────────────────┼───────────────┤
    +│ ACBus           │ 14    │ false                  │ false         │
    +│ Arc             │ 20    │ false                  │ false         │
    +│ Area            │ 1     │ false                  │ false         │
    +│ Line            │ 16    │ false                  │ false         │
    +│ LoadZone        │ 1     │ false                  │ false         │
    +│ StandardLoad    │ 11    │ false                  │ false         │
    +│ TapTransformer  │ 3     │ false                  │ false         │
    +│ ThermalStandard │ 4     │ false                  │ false         │
    +│ Transformer2W   │ 1     │ false                  │ false         │
    +└─────────────────┴───────┴────────────────────────┴───────────────┘
    +
    +Dynamic Components
    +┌──────────────────┬───────┐
    +│ Type             │ Count │
    +├──────────────────┼───────┤
    +│ DynamicGenerator │ 3     │
    +│ DynamicGenerator │ 1     │
    +└──────────────────┴───────┘

    Define Simulation problem using the same parameters:

    julia> sim = Simulation(
    +           ResidualModel, #Type of model used
    +           sys,         #system
    +           mktempdir(),       #path for the simulation output
    +           (0.0, 20.0), #time span
    +           BranchTrip(1.0, Line, "BUS 02-BUS 04-i_1");
    +           console_level = Logging.Info,
    +       )┌ Error: ResidualModel failed to build
    +│   exception =
    +│    No devices in bus BUS 06
    +│    Stacktrace:
    +│      [1] error(s::String)
    +│        @ Base ./error.jl:35
    +│      [2] _reactive_power_redistribution_pv(sys::System, Q_gen::Float64, bus::ACBus)
    +│        @ PowerFlows ~/.julia/packages/PowerFlows/8MBjq/src/post_processing.jl:310
    +│      [3] write_powerflow_solution!(sys::System, result::Vector{Float64})
    +│        @ PowerFlows ~/.julia/packages/PowerFlows/8MBjq/src/post_processing.jl:447
    +│      [4] solve_ac_powerflow!(system::System; kwargs::@Kwargs{})
    +│        @ PowerFlows ~/.julia/packages/PowerFlows/8MBjq/src/nlsolve_ac_powerflow.jl:46
    +│      [5] solve_ac_powerflow!
    +│        @ ~/.julia/packages/PowerFlows/8MBjq/src/nlsolve_ac_powerflow.jl:33 [inlined]
    +│      [6] power_flow_solution!(initial_guess::Vector{Float64}, sys::System, inputs::PowerSimulationsDynamics.SimulationInputs)
    +│        @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation_initialization.jl:14
    +│      [7] macro expansion
    +│        @ ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation_initialization.jl:163 [inlined]
    +│      [8] macro expansion
    +│        @ ~/.julia/packages/TimerOutputs/RsWnF/src/TimerOutput.jl:237 [inlined]
    +│      [9] _calculate_initial_guess!(x0_init::Vector{Float64}, sim::Simulation{ResidualModel})
    +│        @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation_initialization.jl:162
    +│     [10] precalculate_initial_conditions!
    +│        @ ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation_initialization.jl:184 [inlined]
    +│     [11] _pre_initialize_simulation!(sim::Simulation{ResidualModel})
    +│        @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:266
    +│     [12] macro expansion
    +│        @ ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:409 [inlined]
    +│     [13] macro expansion
    +│        @ ~/.julia/packages/TimerOutputs/RsWnF/src/TimerOutput.jl:237 [inlined]
    +│     [14] macro expansion
    +│        @ ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:408 [inlined]
    +│     [15] macro expansion
    +│        @ ~/.julia/packages/TimerOutputs/RsWnF/src/TimerOutput.jl:237 [inlined]
    +│     [16] _build!(sim::Simulation{ResidualModel}; kwargs::@Kwargs{console_level::Base.CoreLogging.LogLevel})
    +│        @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:389
    +│     [17] _build!
    +│        @ ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:378 [inlined]
    +│     [18] (::PowerSimulationsDynamics.var"#109#110"{@Kwargs{console_level::Base.CoreLogging.LogLevel}, Simulation{ResidualModel}})()
    +│        @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:444
    +│     [19] with_logstate(f::Function, logstate::Any)
    +│        @ Base.CoreLogging ./logging.jl:515
    +│     [20] with_logger
    +│        @ ./logging.jl:627 [inlined]
    +│     [21] #build!#108
    +│        @ ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:443 [inlined]
    +│     [22] build!
    +│        @ ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:441 [inlined]
    +│     [23] Simulation(::Type{ResidualModel}, system::System, simulation_folder::String, tspan::Tuple{Float64, Float64}, perturbations::Vector{BranchTrip}; kwargs::@Kwargs{console_level::Base.CoreLogging.LogLevel})
    +│        @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:188
    +│     [24] Simulation
    +│        @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:166 [inlined]
    +│     [25] #Simulation#97
    +│        @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:78 [inlined]
    +│     [26] top-level scope
    +│        @ REPL[1]:1
    +│     [27] eval
    +│        @ ./boot.jl:385 [inlined]
    +│     [28] #21
    +│        @ ~/.julia/packages/Documenter/bYYzK/src/Expanders.jl:721 [inlined]
    +│     [29] cd(f::Documenter.Expanders.var"#21#23"{Module}, dir::String)
    +│        @ Base.Filesystem ./file.jl:112
    +│     [30] (::Documenter.Expanders.var"#20#22"{Documenter.Documents.Page, Module})()
    +│        @ Documenter.Expanders ~/.julia/packages/Documenter/bYYzK/src/Expanders.jl:720
    +│     [31] (::IOCapture.var"#3#5"{DataType, Documenter.Expanders.var"#20#22"{Documenter.Documents.Page, Module}, Task, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}})()
    +│        @ IOCapture ~/.julia/packages/IOCapture/8Uj7o/src/IOCapture.jl:119
    +│     [32] with_logstate(f::Function, logstate::Any)
    +│        @ Base.CoreLogging ./logging.jl:515
    +│     [33] with_logger
    +│        @ ./logging.jl:627 [inlined]
    +│     [34] capture(f::Documenter.Expanders.var"#20#22"{Documenter.Documents.Page, Module}; rethrow::Type, color::Bool)
    +│        @ IOCapture ~/.julia/packages/IOCapture/8Uj7o/src/IOCapture.jl:116
    +│     [35] runner(::Type{Documenter.Expanders.REPLBlocks}, x::Markdown.Code, page::Documenter.Documents.Page, doc::Documenter.Documents.Document)
    +│        @ Documenter.Expanders ~/.julia/packages/Documenter/bYYzK/src/Expanders.jl:719
    +│     [36] dispatch(::Type{Documenter.Expanders.ExpanderPipeline}, ::Markdown.Code, ::Vararg{Any})
    +│        @ Documenter.Utilities.Selectors ~/.julia/packages/Documenter/bYYzK/src/Utilities/Selectors.jl:170
    +│     [37] expand(doc::Documenter.Documents.Document)
    +│        @ Documenter.Expanders ~/.julia/packages/Documenter/bYYzK/src/Expanders.jl:42
    +│     [38] runner(::Type{Documenter.Builder.ExpandTemplates}, doc::Documenter.Documents.Document)
    +│        @ Documenter.Builder ~/.julia/packages/Documenter/bYYzK/src/Builder.jl:226
    +│     [39] dispatch(::Type{Documenter.Builder.DocumentPipeline}, x::Documenter.Documents.Document)
    +│        @ Documenter.Utilities.Selectors ~/.julia/packages/Documenter/bYYzK/src/Utilities/Selectors.jl:170
    +│     [40] #2
    +│        @ ~/.julia/packages/Documenter/bYYzK/src/Documenter.jl:273 [inlined]
    +│     [41] cd(f::Documenter.var"#2#3"{Documenter.Documents.Document}, dir::String)
    +│        @ Base.Filesystem ./file.jl:112
    +│     [42] makedocs(; debug::Bool, format::Documenter.Writers.HTMLWriter.HTML, kwargs::@Kwargs{modules::Vector{Module}, sitename::String, pages::Vector{Any}})
    +│        @ Documenter ~/.julia/packages/Documenter/bYYzK/src/Documenter.jl:272
    +│     [43] top-level scope
    +│        @ ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/docs/make.jl:3
    +│     [44] include(mod::Module, _path::String)
    +│        @ Base ./Base.jl:495
    +│     [45] exec_options(opts::Base.JLOptions)
    +│        @ Base ./client.jl:318
    +│     [46] _start()
    +│        @ Base ./client.jl:552
    +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:434
    +Simulation Summary
    +┌─────────────────────────┬────────────────┐
    +│ Property                │ Value          │
    +├─────────────────────────┼────────────────┤
    +│ Status                  │ BUILD_FAILED   │
    +│ Simulation Type         │ Residual Model │
    +│ Initialized?            │ No             │
    +│ Multimachine system?    │ Yes            │
    +│ Time Span               │ (0.0, 20.0)    │
    +│ Number of States        │ 75             │
    +│ Number of Perturbations │ 1              │
    +└─────────────────────────┴────────────────┘

    We can verify the small signal stability of the system before running the simulation:

    julia> res = small_signal_analysis(sim)ERROR: ArgumentError: matrix contains Infs or NaNs

    Exploring the eigenvalues:

    julia> res.eigenvaluesERROR: type Dict has no field eigenvalues

    We execute the simulation

    julia> execute!(sim, IDA(); abstol = 1e-8)┌ Error: Execution failed
    +│   exception =
    +│    The Simulation status is BUILD_FAILED. Can not continue, correct your inputs and build the simulation again.
    +│    Stacktrace:
    +│      [1] error(s::String)
    +│        @ Base ./error.jl:35
    +│      [2] simulation_pre_step!(sim::Simulation{ResidualModel})
    +│        @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:462
    +│      [3] _execute!(sim::Simulation{ResidualModel}, solver::Sundials.IDA{:Dense, Nothing, Nothing}; kwargs::@Kwargs{abstol::Float64})
    +│        @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:488
    +│      [4] _execute!
    +│        @ ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:486 [inlined]
    +│      [5] (::PowerSimulationsDynamics.var"#117#118"{@Kwargs{abstol::Float64}, Simulation{ResidualModel}, Sundials.IDA{:Dense, Nothing, Nothing}})()
    +│        @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:545
    +│      [6] with_logstate(f::Function, logstate::Any)
    +│        @ Base.CoreLogging ./logging.jl:515
    +│      [7] with_logger
    +│        @ Base.CoreLogging ./logging.jl:627 [inlined]
    +│      [8] #execute!#116
    +│        @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:543 [inlined]
    +│      [9] top-level scope
    +│        @ REPL[1]:1
    +│     [10] eval
    +│        @ ./boot.jl:385 [inlined]
    +│     [11] #21
    +│        @ ~/.julia/packages/Documenter/bYYzK/src/Expanders.jl:721 [inlined]
    +│     [12] cd(f::Documenter.Expanders.var"#21#23"{Module}, dir::String)
    +│        @ Base.Filesystem ./file.jl:112
    +│     [13] (::Documenter.Expanders.var"#20#22"{Documenter.Documents.Page, Module})()
    +│        @ Documenter.Expanders ~/.julia/packages/Documenter/bYYzK/src/Expanders.jl:720
    +│     [14] (::IOCapture.var"#3#5"{DataType, Documenter.Expanders.var"#20#22"{Documenter.Documents.Page, Module}, Task, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}, IOContext{Base.PipeEndpoint}})()
    +│        @ IOCapture ~/.julia/packages/IOCapture/8Uj7o/src/IOCapture.jl:119
    +│     [15] with_logstate(f::Function, logstate::Any)
    +│        @ Base.CoreLogging ./logging.jl:515
    +│     [16] with_logger
    +│        @ ./logging.jl:627 [inlined]
    +│     [17] capture(f::Documenter.Expanders.var"#20#22"{Documenter.Documents.Page, Module}; rethrow::Type, color::Bool)
    +│        @ IOCapture ~/.julia/packages/IOCapture/8Uj7o/src/IOCapture.jl:116
    +│     [18] runner(::Type{Documenter.Expanders.REPLBlocks}, x::Markdown.Code, page::Documenter.Documents.Page, doc::Documenter.Documents.Document)
    +│        @ Documenter.Expanders ~/.julia/packages/Documenter/bYYzK/src/Expanders.jl:719
    +│     [19] dispatch(::Type{Documenter.Expanders.ExpanderPipeline}, ::Markdown.Code, ::Vararg{Any})
    +│        @ Documenter.Utilities.Selectors ~/.julia/packages/Documenter/bYYzK/src/Utilities/Selectors.jl:170
    +│     [20] expand(doc::Documenter.Documents.Document)
    +│        @ Documenter.Expanders ~/.julia/packages/Documenter/bYYzK/src/Expanders.jl:42
    +│     [21] runner(::Type{Documenter.Builder.ExpandTemplates}, doc::Documenter.Documents.Document)
    +│        @ Documenter.Builder ~/.julia/packages/Documenter/bYYzK/src/Builder.jl:226
    +│     [22] dispatch(::Type{Documenter.Builder.DocumentPipeline}, x::Documenter.Documents.Document)
    +│        @ Documenter.Utilities.Selectors ~/.julia/packages/Documenter/bYYzK/src/Utilities/Selectors.jl:170
    +│     [23] #2
    +│        @ ~/.julia/packages/Documenter/bYYzK/src/Documenter.jl:273 [inlined]
    +│     [24] cd(f::Documenter.var"#2#3"{Documenter.Documents.Document}, dir::String)
    +│        @ Base.Filesystem ./file.jl:112
    +│     [25] makedocs(; debug::Bool, format::Documenter.Writers.HTMLWriter.HTML, kwargs::@Kwargs{modules::Vector{Module}, sitename::String, pages::Vector{Any}})
    +│        @ Documenter ~/.julia/packages/Documenter/bYYzK/src/Documenter.jl:272
    +│     [26] top-level scope
    +│        @ ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/docs/make.jl:3
    +│     [27] include(mod::Module, _path::String)
    +│        @ Base ./Base.jl:495
    +│     [28] exec_options(opts::Base.JLOptions)
    +│        @ Base ./client.jl:318
    +│     [29] _start()
    +│        @ Base ./client.jl:552
    +└ @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:547
    +SIMULATION_FAILED::BUILD_STATUS = 7

    Using PowerSimulationsDynamics tools for exploring the results, we can plot all the voltage results for the buses

    julia> result = read_results(sim)
    julia> p = plot();
    julia> for b in get_components(ACBus, sys) + voltage_series = get_voltage_magnitude_series(result, get_number(b)) + plot!( + p, + voltage_series; + xlabel = "Time", + ylabel = "Voltage Magnitude [pu]", + label = "Bus - $(get_name(b))", + ); + endERROR: MethodError: no method matching get_voltage_magnitude_series(::Nothing, ::Int64) + +Closest candidates are: + get_voltage_magnitude_series(!Matched::SimulationResults, ::Int64; dt) + @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation_results.jl:321

    plot

    We can also explore the frequency of the different static generators and storage

    julia> p2 = plot();
    julia> for g in get_components(ThermalStandard, sys) + state_series = get_state_series(result, (get_name(g), :ω)) + plot!( + p2, + state_series; + xlabel = "Time", + ylabel = "Speed [pu]", + label = "$(get_name(g)) - ω", + ); + endERROR: MethodError: no method matching get_state_series(::Nothing, ::Tuple{String, Symbol}) + +Closest candidates are: + get_state_series(!Matched::SimulationResults, ::Tuple{String, Symbol}; dt) + @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation_results.jl:304
    julia> state_series = get_state_series(result, ("Battery", :ω_oc))ERROR: MethodError: no method matching get_state_series(::Nothing, ::Tuple{String, Symbol}) + +Closest candidates are: + get_state_series(!Matched::SimulationResults, ::Tuple{String, Symbol}; dt) + @ PowerSimulationsDynamics ~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation_results.jl:304
    julia> plot!(p2, state_series; xlabel = "Time", ylabel = "Speed [pu]", label = "Battery - ω");ERROR: UndefVarError: `state_series` not defined

    plot

    diff --git a/previews/PR360/tutorials/tutorial_omib/index.html b/previews/PR360/tutorials/tutorial_omib/index.html new file mode 100644 index 000000000..2f8f03983 --- /dev/null +++ b/previews/PR360/tutorials/tutorial_omib/index.html @@ -0,0 +1,95 @@ + +OMIB · PowerSimulationsDynamics.jl

    One Machine against Infinite Bus (OMIB) Simulation

    Originally Contributed by: Rodrigo Henriquez-Auba and José Daniel Lara

    Introduction

    This tutorial will introduce you to the functionality of PowerSimulationsDynamics for running power system dynamic simulations.

    This tutorial presents a simulation of a two-bus system with an infinite bus (represented as a voltage source behind an impedance) at bus 1, and a classic machine on bus 2. The perturbation will be the trip of one of the two circuits (doubling its resistance and impedance) of the line that connects both buses.

    Dependencies

    julia> using PowerSimulationsDynamics
    julia> PSID = PowerSimulationsDynamicsPowerSimulationsDynamics
    julia> using PowerSystemCaseBuilder
    julia> using PowerSystems
    julia> const PSY = PowerSystemsPowerSystems
    julia> using Sundials
    julia> using Plots
    julia> gr()Plots.GRBackend()
    Note

    PowerSystemCaseBuilder.jl is a helper library that makes it easier to reproduce examples in the documentation and tutorials. Normally you would pass your local files to create the system data instead of calling the function build_system. For more details visit PowerSystemCaseBuilder Documentation

    PowerSystems (abbreviated with PSY) is used to properly define the data structure and establish an equilibrium point initial condition with a power flow routine, while Sundials is used to solve the problem defined in PowerSimulationsDynamics.

    Load the system

    We load the system using PowerSystemCaseBuilder.jl:

    julia> omib_sys = build_system(PSIDSystems, "OMIB System")System
    +┌───────────────────┬─────────────┐
    +│ Property          │ Value       │
    +├───────────────────┼─────────────┤
    +│ Name              │             │
    +│ Description       │             │
    +│ System Units Base │ SYSTEM_BASE │
    +│ Base Power        │ 100.0       │
    +│ Base Frequency    │ 60.0        │
    +│ Num Components    │ 10          │
    +└───────────────────┴─────────────┘
    +
    +Static Components
    +┌─────────────────┬───────┬────────────────────────┬───────────────┐
    +│ Type            │ Count │ Has Static Time Series │ Has Forecasts │
    +├─────────────────┼───────┼────────────────────────┼───────────────┤
    +│ ACBus           │ 2     │ false                  │ false         │
    +│ Arc             │ 1     │ false                  │ false         │
    +│ Area            │ 1     │ false                  │ false         │
    +│ Line            │ 2     │ false                  │ false         │
    +│ LoadZone        │ 1     │ false                  │ false         │
    +│ Source          │ 1     │ false                  │ false         │
    +│ ThermalStandard │ 1     │ false                  │ false         │
    +└─────────────────┴───────┴────────────────────────┴───────────────┘
    +
    +Dynamic Components
    +┌──────────────────┬───────┐
    +│ Type             │ Count │
    +├──────────────────┼───────┤
    +│ DynamicGenerator │ 1     │
    +└──────────────────┴───────┘

    Build the simulation and initialize the problem

    The next step is to create the simulation structure. This will create the indexing of our system that will be used to formulate the differential-algebraic system of equations. To do so, it is required to specify the perturbation that will occur in the system. PowerSimulationsDynamics supports multiple types of perturbations. See Perturbations

    Here, we will use a Branch Trip perturbation, that is modeled by modifying the specifying which line we want to trip. In this case we disconnect one of the lines that connects BUS 1 and BUS 2, named "BUS 1-BUS 2-i_1".

    With this, we are ready to create our simulation structure:

    julia> time_span = (0.0, 30.0)(0.0, 30.0)
    julia> perturbation_trip = BranchTrip(1.0, Line, "BUS 1-BUS 2-i_1")BranchTrip(1.0, Line, "BUS 1-BUS 2-i_1")
    julia> sim = PSID.Simulation( + ResidualModel, # Type of formulation + omib_sys, # System + mktempdir(), # Output directory + time_span, + perturbation_trip)Simulation Summary +┌─────────────────────────┬────────────────┐ +│ Property │ Value │ +├─────────────────────────┼────────────────┤ +│ Status │ BUILT │ +│ Simulation Type │ Residual Model │ +│ Initialized? │ Yes │ +│ Multimachine system? │ No │ +│ Time Span │ (0.0, 30.0) │ +│ Number of States │ 6 │ +│ Number of Perturbations │ 1 │ +└─────────────────────────┴────────────────┘

    This will automatically initialize the system by running a power flow and update V_ref, P_ref and hence eq_p (the internal voltage) to match the solution of the power flow. It will also initialize the states in the equilibrium, which can be printed with:

    julia> show_states_initial_value(sim)Voltage Variables
    +====================
    +BUS 1
    +====================
    +Vm 1.05
    +θ 0.0
    +====================
    +BUS 2
    +====================
    +Vm 1.04
    +θ 0.0229
    +====================
    +====================
    +Differential States
    +generator-102-1
    +====================
    +δ 0.1685
    +ω 1.0
    +====================

    Run the Simulation

    Finally, to run the simulation we simply use:

    julia> execute!(
    +           sim, #simulation structure
    +           IDA(), #Sundials DAE Solver
    +           dtmax = 0.02, #Arguments: Maximum timestep allowed
    +       );

    In some cases, the dynamic time step used for the simulation may fail. In such case, the keyword argument dtmax can be used to limit the maximum time step allowed for the simulation.

    Exploring the solution

    First, we need to load the simulation results into memory:

    julia> results = read_results(sim)Simulation Results Summary
    +┌────────────────────────────┬─────────────┐
    +│ Property                   │ Value       │
    +├────────────────────────────┼─────────────┤
    +│ System Base Power [MVA]    │ 100.0       │
    +│ System Base Frequency [Hz] │ 60.0        │
    +│ Time Span                  │ (0.0, 30.0) │
    +│ Total Time Steps           │ 1512        │
    +│ Number of States           │ 6           │
    +│ Total solve time           │ 1.663148539 │
    +└────────────────────────────┴─────────────┘

    PowerSimulationsDynamics has two functions to obtain different states of the solution:

    • get_state_series(results, ("generator-102-1", :δ)): can be used to obtain the solution as a tuple of time and the required state. In this case, we are obtaining the rotor angle of the generator named "generator-102-1"`.
    julia> angle = get_state_series(results, ("generator-102-1", :δ));
    julia> plot(angle, xlabel = "time", ylabel = "rotor angle [rad]", label = "rotor angle")Plot{Plots.GRBackend() n=1}

    plot

    • get_voltage_magnitude_series(results, 102): can be used to obtain the voltage magnitude as a tuple of time and voltage. In this case, we are obtaining the voltage magnitude at bus 102 (where the generator is located).
    julia> volt = get_voltage_magnitude_series(results, 102);
    julia> plot(volt, xlabel = "time", ylabel = "Voltage [pu]", label = "V_2")Plot{Plots.GRBackend() n=1}

    plot

    Optional: Small Signal Analysis

    PowerSimulationsDynamics uses automatic differentiation to compute the reduced Jacobian of the system for the differential states. This can be used to analyze the local stability of the linearized system. We need to re-initialize our simulation:

    julia> sim2 = Simulation(ResidualModel, omib_sys, mktempdir(), time_span)Simulation Summary
    +┌─────────────────────────┬────────────────┐
    +│ Property                │ Value          │
    +├─────────────────────────┼────────────────┤
    +│ Status                  │ BUILT          │
    +│ Simulation Type         │ Residual Model │
    +│ Initialized?            │ Yes            │
    +│ Multimachine system?    │ No             │
    +│ Time Span               │ (0.0, 30.0)    │
    +│ Number of States        │ 6              │
    +│ Number of Perturbations │ 0              │
    +└─────────────────────────┴────────────────┘
    julia> small_sig = small_signal_analysis(sim2)The system is small signal stable

    The small_sig result can report the reduced jacobian for $\delta$ and $\omega$,

    julia> small_sig.reduced_jacobian2×2 Matrix{Float64}:
    +  0.0       376.991
    + -0.466763   -0.317662

    and can also be used to report the eigenvalues of the reduced linearized system:

    julia> small_sig.eigenvalues2-element Vector{ComplexF64}:
    + -0.15883100381194407 - 13.264252847627304im
    + -0.15883100381194407 + 13.264252847627304im
    diff --git a/previews/PR360/tutorials_page/index.html b/previews/PR360/tutorials_page/index.html new file mode 100644 index 000000000..1598ace9d --- /dev/null +++ b/previews/PR360/tutorials_page/index.html @@ -0,0 +1,2 @@ + +SIIP-Examples · PowerSimulationsDynamics.jl