From 172962834c6894629377648372fe02de9b1c6b66 Mon Sep 17 00:00:00 2001 From: "Documenter.jl" Date: Wed, 10 Jul 2024 17:59:05 +0000 Subject: [PATCH] build based on c192d0e --- previews/PR385/api/internal/index.html | 8 +-- previews/PR385/api/public/index.html | 64 ++++++++--------- previews/PR385/power-simulations-dynamics.log | 52 +++++++------- previews/PR385/quick_start_guide/index.html | 2 +- previews/PR385/tutorials/modified_sys.json | 2 +- previews/PR385/tutorials/threebus_sys.json | 2 +- .../tutorials/tutorial_240bus/index.html | 68 +++++++++---------- .../tutorial_dynamic_lines/index.html | 4 +- .../tutorial_inverter_modeling/index.html | 2 +- .../PR385/tutorials/tutorial_omib/index.html | 2 +- 10 files changed, 103 insertions(+), 103 deletions(-) diff --git a/previews/PR385/api/internal/index.html b/previews/PR385/api/internal/index.html index 9b664592e..165713b31 100644 --- a/previews/PR385/api/internal/index.html +++ b/previews/PR385/api/internal/index.html @@ -1,10 +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(;
+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
+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/PR385/api/public/index.html b/previews/PR385/api/public/index.html index 399094bae..a8b9bfb5e 100644 --- a/previews/PR385/api/public/index.html +++ b/previews/PR385/api/public/index.html @@ -4,116 +4,116 @@ 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:

source
PowerSimulationsDynamics.BranchTripType
mutable struct BranchTrip <: Perturbation
+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
+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
+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
+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
+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.MassMatrixModelMethod

Instantiate a MassMatrixModel for ODE inputs.

source
PowerSimulationsDynamics.MassMatrixModelMethod

Instantiate a MassMatrixModel for ForwardDiff calculations

source
PowerSimulationsDynamics.NetworkSwitchType
function NetworkSwitch(
+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.MassMatrixModelMethod

Instantiate a MassMatrixModel for ODE inputs.

source
PowerSimulationsDynamics.MassMatrixModelMethod

Instantiate a MassMatrixModel for ForwardDiff calculations

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(
+)

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.ResidualModelMethod

Instantiate an ResidualModel for ODE inputs.

source
PowerSimulationsDynamics.ResidualModelMethod

Instantiate an ResidualModel for ForwardDiff calculations

source
PowerSimulationsDynamics.SimulationMethod
function Simulation
+)

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.ResidualModelMethod

Instantiate an ResidualModel for ODE inputs.

source
PowerSimulationsDynamics.ResidualModelMethod

Instantiate an ResidualModel for ForwardDiff calculations

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
+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!
+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!(
+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(
+)

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(
+)

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(
+)

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(
+)

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(
+)

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(
+)

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(
+)

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(
+)

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(
+) 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(
+)

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(
+)

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(
+)

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(
+)

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(
+)

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_source_imaginary_current_seriesFunction

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.

source
PowerSimulationsDynamics.get_source_real_current_seriesFunction

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.

source
PowerSimulationsDynamics.get_state_seriesMethod
get_state_series(
+)

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_source_imaginary_current_seriesFunction

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.

source
PowerSimulationsDynamics.get_source_real_current_seriesFunction

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.

source
PowerSimulationsDynamics.get_state_seriesMethod
get_state_series(
     res::SimulationResults,
     ref::Tuple{String, Symbol};
     dt::Union{Nothing, Float64, Vector{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(
+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(
+)

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.read_initial_conditionsMethod

Returns a Dictionary with the resulting initial conditions of the simulation

source
PowerSimulationsDynamics.show_states_initial_valueMethod
show_states_initial_value(res::SimulationResults)

Function to print initial states.

Arguments

  • res::SimulationResults : Simulation Results object that contains the solution
source
PowerSimulationsDynamics.show_states_initial_valueMethod
show_states_initial_value(sim::Simulation)

Function to print initial states.

Arguments

  • sim::Simulation : Simulation object that contains the initial condition
source
PowerSimulationsDynamics.small_signal_analysisMethod
small_signal_analysis(
+)

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.read_initial_conditionsMethod

Returns a Dictionary with the resulting initial conditions of the simulation

source
PowerSimulationsDynamics.show_states_initial_valueMethod
show_states_initial_value(res::SimulationResults)

Function to print initial states.

Arguments

  • res::SimulationResults : Simulation Results object that contains the solution
source
PowerSimulationsDynamics.show_states_initial_valueMethod
show_states_initial_value(sim::Simulation)

Function to print initial states.

Arguments

  • sim::Simulation : Simulation object that contains the initial condition
source
PowerSimulationsDynamics.small_signal_analysisMethod
small_signal_analysis(
         sim::Simulation,
-)

Returns the Small Signal Output object that contains the eigenvalues and participation factors.

Arguments

  • sim::Simulation : Small Signal Output object that contains the eigenvalues and participation factors
source
PowerSimulationsDynamics.summary_eigenvaluesMethod
summary_eigenvalues(
+)

Returns the Small Signal Output object that contains the eigenvalues and participation factors.

Arguments

  • sim::Simulation : Small Signal Output object that contains the eigenvalues and participation factors
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(
+)

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
+)

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

source diff --git a/previews/PR385/power-simulations-dynamics.log b/previews/PR385/power-simulations-dynamics.log index b692a3c8b..5e97fca1c 100644 --- a/previews/PR385/power-simulations-dynamics.log +++ b/previews/PR385/power-simulations-dynamics.log @@ -1,44 +1,44 @@ -┌ Info: 2024-07-10T17:54:43.071 [5568:1]: The reference Bus has a Source connected to it. The frequency reference model will change to ConstantFrequency +┌ Info: 2024-07-10T17:55:16.939 [5567: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-07-10T17:54:43.096 [5568:1]: Pre-Initializing Simulation States +┌ Info: 2024-07-10T17:55:16.963 [5567:1]: Pre-Initializing Simulation States └ @ PowerSimulationsDynamics /home/runner/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:265 -┌ Info: 2024-07-10T17:54:43.097 [5568:1]: Unit System changed to UnitSystem.SYSTEM_BASE = 0 +┌ Info: 2024-07-10T17:55:16.963 [5567:1]: Unit System changed to UnitSystem.SYSTEM_BASE = 0 └ @ PowerSystems /home/runner/.julia/packages/PowerSystems/F94iA/src/base.jl:491 -┌ Info: 2024-07-10T17:54:44.876 [5568:1]: PowerFlow solve converged, the results have been stored in the system +┌ Info: 2024-07-10T17:55:18.659 [5567:1]: PowerFlow solve converged, the results have been stored in the system └ @ PowerFlows /home/runner/.julia/packages/PowerFlows/zesCE/src/nlsolve_ac_powerflow.jl:47 -┌ Info: 2024-07-10T17:54:44.876 [5568:1]: Unit System changed to UnitSystem.DEVICE_BASE = 1 +┌ Info: 2024-07-10T17:55:18.659 [5567:1]: Unit System changed to UnitSystem.DEVICE_BASE = 1 └ @ PowerSystems /home/runner/.julia/packages/PowerSystems/F94iA/src/base.jl:491 -┌ Info: 2024-07-10T17:54:57.756 [5568:1]: Residual from initial guess: max = 4.212807880321634e-11 at 4, total = 5.4841923110646186e-11 +┌ Info: 2024-07-10T17:55:31.162 [5567: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:115 -┌ Info: 2024-07-10T17:54:57.797 [5568:1]: Initialization non-linear solve succeeded with a tolerance of 1.0e-9 using solver trust_region. Saving solution. +┌ Info: 2024-07-10T17:55:31.201 [5567: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:82 -┌ Info: 2024-07-10T17:54:57.797 [5568:1]: Attaching Perturbations +┌ Info: 2024-07-10T17:55:31.201 [5567:1]: Attaching Perturbations └ @ PowerSimulationsDynamics /home/runner/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:299 -┌ Info: 2024-07-10T17:54:58.302 [5568:1]: Simulations status = BUILT +┌ Info: 2024-07-10T17:55:31.697 [5567:1]: Simulations status = BUILT └ @ PowerSimulationsDynamics /home/runner/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:462 -┌ Info: 2024-07-10T17:54:58.303 [5568:1]: +┌ Info: 2024-07-10T17:55:31.697 [5567:1]: │ ─────────────────────────────────────────────────────────────────────────────── │ Time Allocations │ ─────────────── ─────────────── -│ Total measured: 17.2s 819MiB +│ Total measured: 16.6s 821MiB │ │ Section ncalls time %tot alloc %tot │ ─────────────────────────────────────────────────────────────────────────────── -│ Build Simulation 1 17.2s 100.0% 819MiB 100.0% -│ Build Simulation Inputs 1 2.00s 11.6% 124MiB 15.1% -│ Wrap Branches 1 10.1μs 0.0% 208B 0.0% -│ Wrap Dynamic Injectors 1 1.20s 7.0% 78.0MiB 9.5% -│ Calculate MM, DAE_vector, Tota... 1 76.6ms 0.4% 6.28MiB 0.8% -│ Wrap Static Injectors 1 61.3ms 0.4% 1.63MiB 0.2% -│ Pre-initialization 1 4.92s 28.6% 242MiB 29.6% -│ Power Flow solution 1 1.82s 10.6% 43.4MiB 5.3% -│ Initialize Static Injectors 1 2.20s 12.8% 27.4MiB 3.3% -│ Initialize Dynamic Injectors 1 900ms 5.2% 171MiB 20.9% -│ Calculate Jacobian 1 4.68s 27.2% 395MiB 48.3% -│ Make Model Function 1 6.40ms 0.0% 122KiB 0.0% -│ Initial Condition NLsolve refine... 1 5.10s 29.6% 29.9MiB 3.7% -│ Build Perturbations 1 220ms 1.3% 13.6MiB 1.7% -│ Make DiffEq Problem 1 279ms 1.6% 14.0MiB 1.7% +│ Build Simulation 1 16.6s 100.0% 821MiB 100.0% +│ Build Simulation Inputs 1 1.85s 11.1% 126MiB 15.3% +│ Wrap Branches 1 8.98μs 0.0% 208B 0.0% +│ Wrap Dynamic Injectors 1 1.03s 6.2% 80.2MiB 9.8% +│ Calculate MM, DAE_vector, Tota... 1 71.3ms 0.4% 6.28MiB 0.8% +│ Wrap Static Injectors 1 59.0ms 0.4% 1.63MiB 0.2% +│ Pre-initialization 1 4.76s 28.7% 243MiB 29.5% +│ Power Flow solution 1 1.74s 10.5% 43.4MiB 5.3% +│ Initialize Static Injectors 1 2.14s 12.9% 27.6MiB 3.4% +│ Initialize Dynamic Injectors 1 883ms 5.3% 172MiB 20.9% +│ Calculate Jacobian 1 4.52s 27.3% 395MiB 48.1% +│ Make Model Function 1 5.82ms 0.0% 122KiB 0.0% +│ Initial Condition NLsolve refine... 1 4.95s 29.9% 29.9MiB 3.6% +│ Build Perturbations 1 215ms 1.3% 13.6MiB 1.7% +│ Make DiffEq Problem 1 276ms 1.7% 14.0MiB 1.7% │ ─────────────────────────────────────────────────────────────────────────────── │ └ @ PowerSimulationsDynamics /home/runner/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/src/base/simulation.jl:487 diff --git a/previews/PR385/quick_start_guide/index.html b/previews/PR385/quick_start_guide/index.html index 5a6668904..8b07b3529 100644 --- a/previews/PR385/quick_start_guide/index.html +++ b/previews/PR385/quick_start_guide/index.html @@ -90,5 +90,5 @@ │ Time Span │ (0.0, 30.0) │ │ Total Time Steps │ 1502 │ │ Number of States │ 6 │ -│ Total solve time │ 2.140163353 │ +│ Total solve time │ 2.071980721 │ └────────────────────────────┴─────────────┘
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/PR385/tutorials/modified_sys.json b/previews/PR385/tutorials/modified_sys.json index 78abfca50..9b9c20326 100644 --- a/previews/PR385/tutorials/modified_sys.json +++ b/previews/PR385/tutorials/modified_sys.json @@ -1 +1 @@ -{"internal":{"uuid":{"value":"502bb4b0-3933-401e-a8aa-f87c0436833e"},"ext":{},"units_info":null},"data":{"masked_components":[],"supplemental_attribute_manager":{"attributes":[],"associations":[]},"internal":{"uuid":{"value":"0f279ca9-7aa2-4895-8b6b-d92fc75aff5c"},"ext":{},"units_info":null},"time_series_compression_enabled":false,"components":[{"base_power":100.0,"prime_mover_type":"OT","rating":3.333526661060325,"services":[],"bus":{"value":"5455f2b0-c66c-486e-b06a-b17f252d94dc"},"available":true,"name":"generator-102-1","status":true,"active_power":0.7,"dynamic_injector":{"value":"592696bf-97a2-4125-ab68-01fa0deeb72d"},"__metadata__":{"module":"PowerSystems","type":"ThermalStandard"},"fuel":"OTHER","internal":{"uuid":{"value":"56d8f095-0e6b-4e20-88b4-e2606bbcb5be"},"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":{"__metadata__":{"parameters":["InputOutputCurve"],"module":"PowerSystems","type":"CostCurve"},"value_curve":{"input_at_zero":null,"function_data":{"__metadata__":{"module":"InfrastructureSystems","type":"QuadraticFunctionData"},"quadratic_term":0.0,"constant_term":0.0,"proportional_term":1.0},"__metadata__":{"parameters":["QuadraticFunctionData"],"module":"PowerSystems","type":"InputOutputCurve"}},"power_units":"DEVICE_BASE","vom_cost":{"input_at_zero":null,"function_data":{"__metadata__":{"module":"InfrastructureSystems","type":"LinearFunctionData"},"constant_term":0.0,"proportional_term":0.0},"__metadata__":{"parameters":["LinearFunctionData"],"module":"PowerSystems","type":"InputOutputCurve"}}},"__metadata__":{"module":"PowerSystems","type":"ThermalGenerationCost"}},"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":"a66f4d5b-f314-4a7b-a0db-8b3161596693"},"available":true,"name":"generator-103-1","status":true,"active_power":0.8,"dynamic_injector":null,"__metadata__":{"module":"PowerSystems","type":"ThermalStandard"},"fuel":"OTHER","internal":{"uuid":{"value":"1c86def4-b6b9-4eaf-9c4a-851e8fbac733"},"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":{"__metadata__":{"parameters":["InputOutputCurve"],"module":"PowerSystems","type":"CostCurve"},"value_curve":{"input_at_zero":null,"function_data":{"__metadata__":{"module":"InfrastructureSystems","type":"QuadraticFunctionData"},"quadratic_term":0.0,"constant_term":0.0,"proportional_term":1.0},"__metadata__":{"parameters":["QuadraticFunctionData"],"module":"PowerSystems","type":"InputOutputCurve"}},"power_units":"DEVICE_BASE","vom_cost":{"input_at_zero":null,"function_data":{"__metadata__":{"module":"InfrastructureSystems","type":"LinearFunctionData"},"constant_term":0.0,"proportional_term":0.0},"__metadata__":{"parameters":["LinearFunctionData"],"module":"PowerSystems","type":"InputOutputCurve"}}},"__metadata__":{"module":"PowerSystems","type":"ThermalGenerationCost"}},"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},{"rating":2.5,"services":[],"x":0.12,"b":{"from":0.1,"to":0.1},"r":0.01,"available":true,"name":"BUS 1-BUS 3-i_1","reactive_power_flow":0.0,"arc":{"value":"ca02e2c8-1709-4f64-937f-26cd763f2e07"},"__metadata__":{"module":"PowerSystems","type":"Line"},"internal":{"uuid":{"value":"b07e49ec-006e-4a65-bd89-91b6515374fa"},"ext":null,"units_info":null},"ext":{},"active_power_flow":0.0,"angle_limits":{"min":-1.0472,"max":1.0472}},{"rating":2.5,"services":[],"x":0.12,"b":{"from":0.1,"to":0.1},"r":0.01,"available":true,"name":"BUS 1-BUS 2-i_1","reactive_power_flow":0.0,"arc":{"value":"68f916ed-7c53-47f5-90dd-c6f87f2b7582"},"__metadata__":{"module":"PowerSystems","type":"Line"},"internal":{"uuid":{"value":"3033067f-6253-4819-8db3-1502f9a21d7c"},"ext":null,"units_info":null},"ext":{},"active_power_flow":0.0,"angle_limits":{"min":-1.0472,"max":1.0472}},{"rating":2.5,"services":[],"x":0.9,"b":{"from":0.5,"to":0.5},"r":0.02,"available":true,"name":"BUS 2-BUS 3-i_1","reactive_power_flow":0.0,"arc":{"value":"4bb470af-3266-4db3-af4c-abfade6e3e0f"},"__metadata__":{"module":"PowerSystems","type":"Line"},"internal":{"uuid":{"value":"c7d33fa3-73d1-4fbd-bdcb-62b8a2a1a25f"},"ext":null,"units_info":null},"ext":{},"active_power_flow":0.0,"angle_limits":{"min":-1.0472,"max":1.0472}},{"internal_voltage":1.0,"services":[],"bus":{"value":"633ca24d-6567-400e-b37e-a056afc87728"},"available":true,"name":"InfBus","internal_angle":0.0,"active_power":0.0,"dynamic_injector":null,"__metadata__":{"module":"PowerSystems","type":"Source"},"internal":{"uuid":{"value":"705ef190-dd33-45fb-a601-8cd4e0b7a8ef"},"ext":null,"units_info":null},"ext":{},"X_th":5.0e-6,"R_th":0.0,"reactive_power":0.0},{"load_response":0.0,"name":"1","internal":{"uuid":{"value":"8fd456ad-86d1-4d71-8bca-5a784a5af76e"},"ext":null,"units_info":null},"ext":{},"peak_active_power":0.0,"peak_reactive_power":0.0,"__metadata__":{"module":"PowerSystems","type":"Area"}},{"base_power":100.0,"services":[],"bus":{"value":"633ca24d-6567-400e-b37e-a056afc87728"},"max_constant_active_power":0.5,"available":true,"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":"9ccaf330-0ebb-4611-a816-267d2787a997"},"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":"a66f4d5b-f314-4a7b-a0db-8b3161596693"},"max_constant_active_power":0.3,"available":true,"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":"cbaaefb1-31bc-4bfb-9870-654ac0511be4"},"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":"5455f2b0-c66c-486e-b06a-b17f252d94dc"},"max_constant_active_power":1.0,"available":true,"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":"13f6e537-49c2-4c4f-b1d6-def9cf8106bf"},"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},{"base_power":100.0,"shaft":{"internal":{"uuid":{"value":"54181c07-e2c9-4e33-9ce1-a870d6961f56"},"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":"66cc222b-de1a-40e0-bbfc-a473bf3c13ea"},"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":"592696bf-97a2-4125-ab68-01fa0deeb72d"},"ext":null,"units_info":null},"ext":{},"machine":{"internal":{"uuid":{"value":"0f8620ad-f9d8-46d5-905a-1feccad1c6c7"},"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":"33181db5-8eb0-43a5-8a86-5ba69e4e0416"},"ext":null,"units_info":null},"n_states":0,"ext":{},"states":[],"__metadata__":{"module":"PowerSystems","type":"PSSFixed"}},"prime_mover":{"P_ref":1.0,"internal":{"uuid":{"value":"36396bb4-f4e1-42d4-a413-cf2fdd272b2e"},"ext":null,"units_info":null},"efficiency":1.0,"n_states":0,"ext":{},"states":[],"__metadata__":{"module":"PowerSystems","type":"TGFixed"}}},{"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":"a66f4d5b-f314-4a7b-a0db-8b3161596693"},"ext":null,"units_info":null},"area":{"value":"8fd456ad-86d1-4d71-8bca-5a784a5af76e"},"ext":{},"voltage_limits":{"min":0.9,"max":1.1},"load_zone":{"value":"0d1f0e06-4d12-483a-ac17-6be9401346d7"}},{"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":"633ca24d-6567-400e-b37e-a056afc87728"},"ext":null,"units_info":null},"area":{"value":"8fd456ad-86d1-4d71-8bca-5a784a5af76e"},"ext":{},"voltage_limits":{"min":0.9,"max":1.1},"load_zone":{"value":"0d1f0e06-4d12-483a-ac17-6be9401346d7"}},{"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":"5455f2b0-c66c-486e-b06a-b17f252d94dc"},"ext":null,"units_info":null},"area":{"value":"8fd456ad-86d1-4d71-8bca-5a784a5af76e"},"ext":{},"voltage_limits":{"min":0.9,"max":1.1},"load_zone":{"value":"0d1f0e06-4d12-483a-ac17-6be9401346d7"}},{"name":"1","internal":{"uuid":{"value":"0d1f0e06-4d12-483a-ac17-6be9401346d7"},"ext":null,"units_info":null},"ext":{},"peak_active_power":1.8,"peak_reactive_power":0.5,"__metadata__":{"module":"PowerSystems","type":"LoadZone"}},{"internal":{"uuid":{"value":"ca02e2c8-1709-4f64-937f-26cd763f2e07"},"ext":null,"units_info":null},"to":{"value":"a66f4d5b-f314-4a7b-a0db-8b3161596693"},"from":{"value":"633ca24d-6567-400e-b37e-a056afc87728"},"__metadata__":{"module":"PowerSystems","type":"Arc"}},{"internal":{"uuid":{"value":"68f916ed-7c53-47f5-90dd-c6f87f2b7582"},"ext":null,"units_info":null},"to":{"value":"5455f2b0-c66c-486e-b06a-b17f252d94dc"},"from":{"value":"633ca24d-6567-400e-b37e-a056afc87728"},"__metadata__":{"module":"PowerSystems","type":"Arc"}},{"internal":{"uuid":{"value":"4bb470af-3266-4db3-af4c-abfade6e3e0f"},"ext":null,"units_info":null},"to":{"value":"a66f4d5b-f314-4a7b-a0db-8b3161596693"},"from":{"value":"5455f2b0-c66c-486e-b06a-b17f252d94dc"},"__metadata__":{"module":"PowerSystems","type":"Arc"}}],"subsystems":{},"version_info":{"julia_version":"1.10.4","package_info":"Status `~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/docs/Manifest.toml`\n [47edcb42] ADTypes v1.5.3\n [a4c015fc] ANSIColoredPrinters v0.0.1\n [1520ce14] AbstractTrees v0.4.5\n [7d9f7c33] Accessors v0.1.36\n [79e6a3ab] Adapt v4.0.4\n [ec485272] ArnoldiMethod v0.4.0\n [4fba245c] ArrayInterface v7.12.0\n [4c555306] ArrayLayouts v1.10.2\n [d1d4a3ce] BitFlags v0.1.9\n [62783981] BitTwiddlingConvenienceFunctions v0.1.6\n [a74b3585] Blosc v0.7.3\n [fa961155] CEnum v0.5.0\n [2a0fbf3d] CPUSummary v0.2.6\n [336ed68f] CSV v0.10.14\n [d360d2e6] ChainRulesCore v1.24.0\n [fb6a15b2] CloseOpenIntervals v0.1.13\n [944b1d66] CodecZlib v0.7.5\n [35d6a980] ColorSchemes v3.25.0\n [3da002f7] ColorTypes v0.11.5\n [c3611d14] ColorVectorSpace v0.10.0\n [5ae59095] Colors v0.12.11\n [38540f10] CommonSolve v0.2.4\n [bbf7d656] CommonSubexpressions v0.3.0\n [f70d9fcc] CommonWorldInvalidations v1.0.0\n [34da2185] Compat v4.15.0\n [a33af91c] CompositionsBase v0.1.2\n [2569d6c7] ConcreteStructs v0.2.3\n [f0e56b4a] ConcurrentUtilities v2.4.2\n [187b0558] ConstructionBase v1.5.5\n [d38c429a] Contour v0.6.3\n [adafc99b] CpuId v0.3.1\n [a8cc5b0e] Crayons v4.1.1\n [a10d1c49] DBInterface v2.6.1\n [9a962f9c] DataAPI v1.16.0\n [a93c6f00] DataFrames v1.6.1\n [864edb3b] DataStructures v0.18.20\n [e2d170a0] DataValueInterfaces v1.0.0\n [8bb1440f] DelimitedFiles v1.9.1\n [2b5f629d] DiffEqBase v6.151.5\n [163ba53b] DiffResults v1.1.0\n [b552c78f] DiffRules v1.15.1\n [a0c0ee7d] DifferentiationInterface v0.5.7\n [b4f34e82] Distances v0.10.11\n [ffbed154] DocStringExtensions v0.9.3\n⌅ [e30172f5] Documenter v0.27.25\n [35a29f4d] DocumenterTools v0.1.19\n [4e289a0a] EnumX v1.0.4\n [f151be2c] EnzymeCore v0.7.6\n [460bff9d] ExceptionUnwrapping v0.1.10\n [d4d017d3] ExponentialUtilities v1.26.1\n [e2ba6199] ExprTools v0.1.10\n [c87230d0] FFMPEG v0.4.1\n [7034ab61] FastBroadcast v0.3.4\n [9aa1b823] FastClosures v0.3.2\n [29a986be] FastLapackInterface v2.0.4\n [48062228] FilePathsBase v0.9.21\n [1a297f60] FillArrays v1.11.0\n [6a86dc24] FiniteDiff v2.23.1\n [53c48c17] FixedPointNumbers v0.8.5\n [1fa38f19] Format v1.3.7\n [f6369f11] ForwardDiff v0.10.36\n [069b7b12] FunctionWrappers v1.1.3\n [77dc65aa] FunctionWrappersWrappers v0.1.3\n [46192b85] GPUArraysCore v0.1.6\n⌃ [28b8d3ca] GR v0.73.5\n [c145ed77] GenericSchur v0.5.4\n [86223c79] Graphs v1.11.2\n [42e2da0e] Grisu v1.0.2\n [708ec375] Gumbo v0.8.2\n [c8ec2601] H5Zblosc v0.1.2\n [f67ccb44] HDF5 v0.17.2\n [cd3eb016] HTTP v1.10.8\n [3e5b6fbb] HostCPUFeatures v0.1.17\n [b5f81e59] IOCapture v0.2.5\n [615f187c] IfElse v0.1.1\n [d25df0c9] Inflate v0.1.5\n [2cd47ed4] InfrastructureSystems v2.0.2\n [842dd82b] InlineStrings v1.4.1\n [3587e190] InverseFunctions v0.1.14\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.6.0\n [ba0b0d4f] Krylov v0.9.6\n [b964fa9f] LaTeXStrings v1.3.1\n [23fbe1c1] Latexify v0.16.4\n [10f19ff3] LayoutPointers v0.1.17\n [5078a376] LazyArrays v2.1.7\n [1d6d02ad] LeftChildRightSiblingTrees v0.2.0\n [d3d80556] LineSearches v7.2.0\n [7ed4a6bd] LinearSolve v2.30.2\n [2ab3a3ac] LogExpFunctions v0.3.28\n [e6f89c97] LoggingExtras v1.0.3\n [bdcacae8] LoopVectorization v0.12.171\n⌅ [33e6dc65] MKL v0.6.3\n [3da0fdf6] MPIPreferences v0.1.11\n [1914dd2f] MacroTools v0.5.13\n [d125e4d3] ManualMemory v0.1.8\n [299715c1] MarchingCubes v0.1.9\n [bb5d69b7] MaybeInplace v0.1.3\n [739be429] MbedTLS v1.1.9\n [442fdcdd] Measures v0.3.2\n [e1d29d7a] Missings v1.2.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.13.1\n [6fe1bfb0] OffsetArrays v1.14.1\n [4d8831e6] OpenSSL v1.4.3\n [bac558e1] OrderedCollections v1.6.3\n [1dea7af3] OrdinaryDiffEq v6.85.0\n [65ce6f38] PackageExtensionCompat v1.0.2\n [d96e819e] Parameters v0.12.3\n [46dd5b70] Pardiso v0.5.7\n [69de0a69] Parsers v2.8.1\n [b98c9c47] Pipe v1.3.0\n [ccf2f8ad] PlotThemes v3.2.0\n [995b91a9] PlotUtils v1.4.1\n [91a5bcdd] Plots v1.40.5\n [f517fe37] Polyester v0.7.15\n [1d0040c9] PolyesterWeave v0.2.2\n [2dfb63ee] PooledArrays v1.4.3\n [dd99e9e3] PowerFlowData v1.5.0\n [94fada2c] PowerFlows v0.7.0\n [bed98974] PowerNetworkMatrices v0.11.0\n [398b2ede] PowerSimulationsDynamics v0.15.0 `~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl`\n [f00506e0] PowerSystemCaseBuilder v1.3.3\n [bcd98974] PowerSystems v4.1.2\n [d236fae5] PreallocationTools v0.4.22\n [aea7be01] PrecompileTools v1.2.1\n [21216c6a] Preferences v1.4.3\n [08abe8d2] PrettyTables v2.3.2\n [33c8b6b6] ProgressLogging v0.1.4\n [3cdcf5f2] RecipesBase v1.3.4\n [01d81517] RecipesPipeline v0.6.12\n [731186ca] RecursiveArrayTools v3.26.0\n [f2c3362d] RecursiveFactorization v0.2.23\n [189a3867] Reexport v1.2.2\n [05181044] RelocatableFolders v1.0.1\n [ae029012] Requires v1.3.0\n [7e49a35a] RuntimeGeneratedFunctions v0.5.13\n [94e857df] SIMDTypes v0.1.0\n [476501e8] SLEEFPirates v0.6.43\n [0aa819cd] SQLite v1.6.1\n [322a6be2] Sass v0.2.0\n [0bca4576] SciMLBase v2.42.0\n [c0aeaf25] SciMLOperators v0.3.8\n [53ae85a6] SciMLStructures v1.4.1\n [6c6a2e73] Scratch v1.2.1\n [91c51154] SentinelArrays v1.4.5\n [efcf1570] Setfield v1.1.1\n [992d4aef] Showoff v1.0.3\n [777ac1f9] SimpleBufferStream v1.1.0\n [727e6d20] SimpleNonlinearSolve v1.10.1\n [699a6c99] SimpleTraits v0.9.4\n [ce78b400] SimpleUnPack v1.1.0\n [a2af1166] SortingAlgorithms v1.2.1\n [47a9eef4] SparseDiffTools v2.19.0\n [0a514795] SparseMatrixColorings v0.3.3\n [e56a9233] Sparspak v0.3.9\n [276daf66] SpecialFunctions v2.4.0\n [aedffcd0] Static v1.1.0\n [0d7ed370] StaticArrayInterface v1.5.1\n [90137ffa] StaticArrays v1.9.7\n [1e83bf80] StaticArraysCore v1.4.3\n [82ae8749] StatsAPI v1.7.0\n [2913bbd2] StatsBase v0.34.3\n [7792a7ef] StrideArraysCore v0.5.7\n [69024149] StringEncodings v0.3.7\n [892a3eda] StringManipulation v0.3.4\n [856f2bd8] StructTypes v1.10.0\n [c3572dad] Sundials v4.24.0\n [2efcf032] SymbolicIndexingInterface v0.3.26\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.24.2\n [a759f4b9] TimerOutputs v0.5.24\n [3bb67fe8] TranscodingStreams v0.11.0\n [d5829a12] TriangularSolve v0.2.1\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.4\n [1986cc42] Unitful v1.20.0\n [45397f5d] UnitfulLatexify v1.6.4\n [41fe7b60] Unzip v0.2.0\n [3d5dd08c] VectorizationBase v0.21.70\n [19fa3120] VertexSafeGraphs v0.2.0\n [ea10d353] WeakRefStrings v1.4.2\n [76eceee3] WorkerUtilities v1.6.1\n [ddb6d928] YAML v0.4.11\n [0b7ba130] Blosc_jll v1.21.5+0\n [6e34b625] Bzip2_jll v1.0.8+1\n [83423d85] Cairo_jll v1.18.0+2\n [2702e6a9] EpollShim_jll v0.0.20230411+0\n [2e619515] Expat_jll v2.6.2+0\n⌅ [b22a6f82] FFMPEG_jll v4.4.2+2\n [a3f928ae] Fontconfig_jll v2.13.96+0\n [d7e528f0] FreeType2_jll v2.13.2+0\n [559328eb] FriBidi_jll v1.0.14+0\n [0656b61e] GLFW_jll v3.4.0+0\n⌅ [d2c73de3] GR_jll v0.73.5+0\n [78b55507] Gettext_jll v0.21.0+0\n [7746bdde] Glib_jll v2.80.2+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 v2024.2.0+0\n [aacddb02] JpegTurbo_jll v3.0.3+0\n [c1c5ebd0] LAME_jll v3.100.2+0\n⌅ [88015f11] LERC_jll v3.0.0+1\n [1d63c593] LLVMOpenMP_jll v15.0.7+0\n [dd4b983a] LZO_jll v2.10.2+0\n⌅ [e9f186c6] Libffi_jll v3.2.2+1\n [d4300ac3] Libgcrypt_jll v1.8.11+0\n [7e76a0d4] Libglvnd_jll v1.6.0+0\n [7add5ba3] Libgpg_error_jll v1.49.0+0\n [94ce4f54] Libiconv_jll v1.17.0+0\n [4b2f31a3] Libmount_jll v2.40.1+0\n⌅ [89763e89] Libtiff_jll v4.5.1+1\n [38a345b3] Libuuid_jll v2.40.1+0\n [5ced341a] Lz4_jll v1.9.4+0\n [856f044c] MKL_jll v2024.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.43.4+0\n⌅ [c0090381] Qt6Base_jll v6.5.2+2\n [76ed43ae] SQLite_jll v3.45.3+0\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.13.1+0\n [aed1982a] XSLT_jll v1.1.41+0\n [ffd25f8a] XZ_jll v5.4.6+0\n [f67eecfb] Xorg_libICE_jll v1.1.1+0\n [c834827a] Xorg_libSM_jll v1.2.4+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.6+0\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.11+0\n [14d82f49] Xorg_libpthread_stubs_jll v0.1.1+0\n [c7cfdc94] Xorg_libxcb_jll v1.17.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.6+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.9.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.43+1\n [47bcb7c8] libsass_jll v3.6.6+0\n [f27f6e37] libvorbis_jll v1.3.7+1\n [009596ad] mtdev_jll v1.1.6+0\n [1317d2d5] oneTBB_jll v2021.12.0+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.1.1+0\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+4\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"},"time_series_in_memory":false},"units_settings":{"base_value":100.0,"unit_system":"SYSTEM_BASE","__metadata__":{"module":"InfrastructureSystems","type":"SystemUnitsSettings"}},"frequency":60.0,"runchecks":true,"metadata":{"name":null,"description":null,"__metadata__":{"module":"PowerSystems","type":"SystemMetadata"}},"data_format_version":"4.0.0"} \ No newline at end of file +{"internal":{"uuid":{"value":"54253cda-9c46-4c98-9feb-b11d2d9a2c6e"},"ext":{},"units_info":null},"data":{"masked_components":[],"supplemental_attribute_manager":{"attributes":[],"associations":[]},"internal":{"uuid":{"value":"514bdf9e-2bd7-40bb-a2a3-0e7a676ab21d"},"ext":{},"units_info":null},"time_series_compression_enabled":false,"components":[{"name":"1","internal":{"uuid":{"value":"76d5a564-f87b-476f-9568-0ff8f0bb30a5"},"ext":null,"units_info":null},"ext":{},"peak_active_power":1.8,"peak_reactive_power":0.5,"__metadata__":{"module":"PowerSystems","type":"LoadZone"}},{"internal_voltage":1.0,"services":[],"bus":{"value":"15b454a0-d292-4fbf-8dbe-ea5999b03cd5"},"available":true,"name":"InfBus","internal_angle":0.0,"active_power":0.0,"dynamic_injector":null,"__metadata__":{"module":"PowerSystems","type":"Source"},"internal":{"uuid":{"value":"83def83e-4c15-47e4-b30d-94a965ceb5ed"},"ext":null,"units_info":null},"ext":{},"X_th":5.0e-6,"R_th":0.0,"reactive_power":0.0},{"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":"d8b8832e-3112-43e8-9f7d-66feef9fa778"},"ext":null,"units_info":null},"area":{"value":"0657d78c-8044-486e-ba68-8bb2f8f18c15"},"ext":{},"voltage_limits":{"min":0.9,"max":1.1},"load_zone":{"value":"76d5a564-f87b-476f-9568-0ff8f0bb30a5"}},{"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":"15b454a0-d292-4fbf-8dbe-ea5999b03cd5"},"ext":null,"units_info":null},"area":{"value":"0657d78c-8044-486e-ba68-8bb2f8f18c15"},"ext":{},"voltage_limits":{"min":0.9,"max":1.1},"load_zone":{"value":"76d5a564-f87b-476f-9568-0ff8f0bb30a5"}},{"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":"7bef6f94-7532-41b7-9a6e-7a64b24524c2"},"ext":null,"units_info":null},"area":{"value":"0657d78c-8044-486e-ba68-8bb2f8f18c15"},"ext":{},"voltage_limits":{"min":0.9,"max":1.1},"load_zone":{"value":"76d5a564-f87b-476f-9568-0ff8f0bb30a5"}},{"internal":{"uuid":{"value":"e6b1f83e-461d-4125-b8b5-1c28ea47e6b1"},"ext":null,"units_info":null},"to":{"value":"d8b8832e-3112-43e8-9f7d-66feef9fa778"},"from":{"value":"15b454a0-d292-4fbf-8dbe-ea5999b03cd5"},"__metadata__":{"module":"PowerSystems","type":"Arc"}},{"internal":{"uuid":{"value":"60573a02-634d-4b33-9da0-be9d021c6324"},"ext":null,"units_info":null},"to":{"value":"7bef6f94-7532-41b7-9a6e-7a64b24524c2"},"from":{"value":"15b454a0-d292-4fbf-8dbe-ea5999b03cd5"},"__metadata__":{"module":"PowerSystems","type":"Arc"}},{"internal":{"uuid":{"value":"6edd0ec3-bd6b-4091-a4c3-b85057c54295"},"ext":null,"units_info":null},"to":{"value":"d8b8832e-3112-43e8-9f7d-66feef9fa778"},"from":{"value":"7bef6f94-7532-41b7-9a6e-7a64b24524c2"},"__metadata__":{"module":"PowerSystems","type":"Arc"}},{"base_power":100.0,"services":[],"bus":{"value":"15b454a0-d292-4fbf-8dbe-ea5999b03cd5"},"max_constant_active_power":0.5,"available":true,"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":"389ecdbf-4160-4420-9776-15b2fc16c91c"},"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":"d8b8832e-3112-43e8-9f7d-66feef9fa778"},"max_constant_active_power":0.3,"available":true,"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":"01e608f5-05a6-48d0-bdab-5c19394f8b6e"},"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":"7bef6f94-7532-41b7-9a6e-7a64b24524c2"},"max_constant_active_power":1.0,"available":true,"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":"41b75085-badd-451e-a863-9f08885d2577"},"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},{"load_response":0.0,"name":"1","internal":{"uuid":{"value":"0657d78c-8044-486e-ba68-8bb2f8f18c15"},"ext":null,"units_info":null},"ext":{},"peak_active_power":0.0,"peak_reactive_power":0.0,"__metadata__":{"module":"PowerSystems","type":"Area"}},{"base_power":100.0,"shaft":{"internal":{"uuid":{"value":"5ccb6fc8-6f40-45f2-a181-d4917fa8b09c"},"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":"c974c44f-fb21-42ba-824e-8dfbc1524ace"},"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":"9a80b6cc-e474-459b-bc7d-73427dd8f305"},"ext":null,"units_info":null},"ext":{},"machine":{"internal":{"uuid":{"value":"953f8dd8-848e-4ce9-a7cd-3e710ace42be"},"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":"1a2de760-bede-4f83-8849-6d6675e06dd0"},"ext":null,"units_info":null},"n_states":0,"ext":{},"states":[],"__metadata__":{"module":"PowerSystems","type":"PSSFixed"}},"prime_mover":{"P_ref":1.0,"internal":{"uuid":{"value":"d1419ef3-ee21-4435-800a-e179c8e09ff3"},"ext":null,"units_info":null},"efficiency":1.0,"n_states":0,"ext":{},"states":[],"__metadata__":{"module":"PowerSystems","type":"TGFixed"}}},{"rating":2.5,"services":[],"x":0.12,"b":{"from":0.1,"to":0.1},"r":0.01,"available":true,"name":"BUS 1-BUS 3-i_1","reactive_power_flow":0.0,"arc":{"value":"e6b1f83e-461d-4125-b8b5-1c28ea47e6b1"},"__metadata__":{"module":"PowerSystems","type":"Line"},"internal":{"uuid":{"value":"7cf012a1-909a-4e3f-a14d-2e636c49b3c7"},"ext":null,"units_info":null},"ext":{},"active_power_flow":0.0,"angle_limits":{"min":-1.0472,"max":1.0472}},{"rating":2.5,"services":[],"x":0.12,"b":{"from":0.1,"to":0.1},"r":0.01,"available":true,"name":"BUS 1-BUS 2-i_1","reactive_power_flow":0.0,"arc":{"value":"60573a02-634d-4b33-9da0-be9d021c6324"},"__metadata__":{"module":"PowerSystems","type":"Line"},"internal":{"uuid":{"value":"6a262e5c-ea4a-4622-b9b7-cdb2450fd20e"},"ext":null,"units_info":null},"ext":{},"active_power_flow":0.0,"angle_limits":{"min":-1.0472,"max":1.0472}},{"rating":2.5,"services":[],"x":0.9,"b":{"from":0.5,"to":0.5},"r":0.02,"available":true,"name":"BUS 2-BUS 3-i_1","reactive_power_flow":0.0,"arc":{"value":"6edd0ec3-bd6b-4091-a4c3-b85057c54295"},"__metadata__":{"module":"PowerSystems","type":"Line"},"internal":{"uuid":{"value":"ead04ec7-a1b6-474e-a598-57c2f310dfb9"},"ext":null,"units_info":null},"ext":{},"active_power_flow":0.0,"angle_limits":{"min":-1.0472,"max":1.0472}},{"base_power":100.0,"prime_mover_type":"OT","rating":3.333526661060325,"services":[],"bus":{"value":"7bef6f94-7532-41b7-9a6e-7a64b24524c2"},"available":true,"name":"generator-102-1","status":true,"active_power":0.7,"dynamic_injector":{"value":"9a80b6cc-e474-459b-bc7d-73427dd8f305"},"__metadata__":{"module":"PowerSystems","type":"ThermalStandard"},"fuel":"OTHER","internal":{"uuid":{"value":"c0d77bfb-336b-4630-8890-e07f72aca664"},"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":{"__metadata__":{"parameters":["InputOutputCurve"],"module":"PowerSystems","type":"CostCurve"},"value_curve":{"input_at_zero":null,"function_data":{"__metadata__":{"module":"InfrastructureSystems","type":"QuadraticFunctionData"},"quadratic_term":0.0,"constant_term":0.0,"proportional_term":1.0},"__metadata__":{"parameters":["QuadraticFunctionData"],"module":"PowerSystems","type":"InputOutputCurve"}},"power_units":"DEVICE_BASE","vom_cost":{"input_at_zero":null,"function_data":{"__metadata__":{"module":"InfrastructureSystems","type":"LinearFunctionData"},"constant_term":0.0,"proportional_term":0.0},"__metadata__":{"parameters":["LinearFunctionData"],"module":"PowerSystems","type":"InputOutputCurve"}}},"__metadata__":{"module":"PowerSystems","type":"ThermalGenerationCost"}},"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":"d8b8832e-3112-43e8-9f7d-66feef9fa778"},"available":true,"name":"generator-103-1","status":true,"active_power":0.8,"dynamic_injector":null,"__metadata__":{"module":"PowerSystems","type":"ThermalStandard"},"fuel":"OTHER","internal":{"uuid":{"value":"026e4998-e54a-4d0a-ac46-241682474a16"},"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":{"__metadata__":{"parameters":["InputOutputCurve"],"module":"PowerSystems","type":"CostCurve"},"value_curve":{"input_at_zero":null,"function_data":{"__metadata__":{"module":"InfrastructureSystems","type":"QuadraticFunctionData"},"quadratic_term":0.0,"constant_term":0.0,"proportional_term":1.0},"__metadata__":{"parameters":["QuadraticFunctionData"],"module":"PowerSystems","type":"InputOutputCurve"}},"power_units":"DEVICE_BASE","vom_cost":{"input_at_zero":null,"function_data":{"__metadata__":{"module":"InfrastructureSystems","type":"LinearFunctionData"},"constant_term":0.0,"proportional_term":0.0},"__metadata__":{"parameters":["LinearFunctionData"],"module":"PowerSystems","type":"InputOutputCurve"}}},"__metadata__":{"module":"PowerSystems","type":"ThermalGenerationCost"}},"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}],"subsystems":{},"version_info":{"julia_version":"1.10.4","package_info":"Status `~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/docs/Manifest.toml`\n [47edcb42] ADTypes v1.5.3\n [a4c015fc] ANSIColoredPrinters v0.0.1\n [1520ce14] AbstractTrees v0.4.5\n [7d9f7c33] Accessors v0.1.36\n [79e6a3ab] Adapt v4.0.4\n [ec485272] ArnoldiMethod v0.4.0\n [4fba245c] ArrayInterface v7.12.0\n [4c555306] ArrayLayouts v1.10.2\n [d1d4a3ce] BitFlags v0.1.9\n [62783981] BitTwiddlingConvenienceFunctions v0.1.6\n [a74b3585] Blosc v0.7.3\n [fa961155] CEnum v0.5.0\n [2a0fbf3d] CPUSummary v0.2.6\n [336ed68f] CSV v0.10.14\n [d360d2e6] ChainRulesCore v1.24.0\n [fb6a15b2] CloseOpenIntervals v0.1.13\n [944b1d66] CodecZlib v0.7.5\n [35d6a980] ColorSchemes v3.25.0\n [3da002f7] ColorTypes v0.11.5\n [c3611d14] ColorVectorSpace v0.10.0\n [5ae59095] Colors v0.12.11\n [38540f10] CommonSolve v0.2.4\n [bbf7d656] CommonSubexpressions v0.3.0\n [f70d9fcc] CommonWorldInvalidations v1.0.0\n [34da2185] Compat v4.15.0\n [a33af91c] CompositionsBase v0.1.2\n [2569d6c7] ConcreteStructs v0.2.3\n [f0e56b4a] ConcurrentUtilities v2.4.2\n [187b0558] ConstructionBase v1.5.5\n [d38c429a] Contour v0.6.3\n [adafc99b] CpuId v0.3.1\n [a8cc5b0e] Crayons v4.1.1\n [a10d1c49] DBInterface v2.6.1\n [9a962f9c] DataAPI v1.16.0\n [a93c6f00] DataFrames v1.6.1\n [864edb3b] DataStructures v0.18.20\n [e2d170a0] DataValueInterfaces v1.0.0\n [8bb1440f] DelimitedFiles v1.9.1\n [2b5f629d] DiffEqBase v6.151.5\n [163ba53b] DiffResults v1.1.0\n [b552c78f] DiffRules v1.15.1\n [a0c0ee7d] DifferentiationInterface v0.5.7\n [b4f34e82] Distances v0.10.11\n [ffbed154] DocStringExtensions v0.9.3\n⌅ [e30172f5] Documenter v0.27.25\n [35a29f4d] DocumenterTools v0.1.19\n [4e289a0a] EnumX v1.0.4\n [f151be2c] EnzymeCore v0.7.6\n [460bff9d] ExceptionUnwrapping v0.1.10\n [d4d017d3] ExponentialUtilities v1.26.1\n [e2ba6199] ExprTools v0.1.10\n [c87230d0] FFMPEG v0.4.1\n [7034ab61] FastBroadcast v0.3.4\n [9aa1b823] FastClosures v0.3.2\n [29a986be] FastLapackInterface v2.0.4\n [48062228] FilePathsBase v0.9.21\n [1a297f60] FillArrays v1.11.0\n [6a86dc24] FiniteDiff v2.23.1\n [53c48c17] FixedPointNumbers v0.8.5\n [1fa38f19] Format v1.3.7\n [f6369f11] ForwardDiff v0.10.36\n [069b7b12] FunctionWrappers v1.1.3\n [77dc65aa] FunctionWrappersWrappers v0.1.3\n [46192b85] GPUArraysCore v0.1.6\n⌃ [28b8d3ca] GR v0.73.5\n [c145ed77] GenericSchur v0.5.4\n [86223c79] Graphs v1.11.2\n [42e2da0e] Grisu v1.0.2\n [708ec375] Gumbo v0.8.2\n [c8ec2601] H5Zblosc v0.1.2\n [f67ccb44] HDF5 v0.17.2\n [cd3eb016] HTTP v1.10.8\n [3e5b6fbb] HostCPUFeatures v0.1.17\n [b5f81e59] IOCapture v0.2.5\n [615f187c] IfElse v0.1.1\n [d25df0c9] Inflate v0.1.5\n [2cd47ed4] InfrastructureSystems v2.0.2\n [842dd82b] InlineStrings v1.4.1\n [3587e190] InverseFunctions v0.1.14\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.6.0\n [ba0b0d4f] Krylov v0.9.6\n [b964fa9f] LaTeXStrings v1.3.1\n [23fbe1c1] Latexify v0.16.4\n [10f19ff3] LayoutPointers v0.1.17\n [5078a376] LazyArrays v2.1.7\n [1d6d02ad] LeftChildRightSiblingTrees v0.2.0\n [d3d80556] LineSearches v7.2.0\n [7ed4a6bd] LinearSolve v2.30.2\n [2ab3a3ac] LogExpFunctions v0.3.28\n [e6f89c97] LoggingExtras v1.0.3\n [bdcacae8] LoopVectorization v0.12.171\n⌅ [33e6dc65] MKL v0.6.3\n [3da0fdf6] MPIPreferences v0.1.11\n [1914dd2f] MacroTools v0.5.13\n [d125e4d3] ManualMemory v0.1.8\n [299715c1] MarchingCubes v0.1.9\n [bb5d69b7] MaybeInplace v0.1.3\n [739be429] MbedTLS v1.1.9\n [442fdcdd] Measures v0.3.2\n [e1d29d7a] Missings v1.2.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.13.1\n [6fe1bfb0] OffsetArrays v1.14.1\n [4d8831e6] OpenSSL v1.4.3\n [bac558e1] OrderedCollections v1.6.3\n [1dea7af3] OrdinaryDiffEq v6.85.0\n [65ce6f38] PackageExtensionCompat v1.0.2\n [d96e819e] Parameters v0.12.3\n [46dd5b70] Pardiso v0.5.7\n [69de0a69] Parsers v2.8.1\n [b98c9c47] Pipe v1.3.0\n [ccf2f8ad] PlotThemes v3.2.0\n [995b91a9] PlotUtils v1.4.1\n [91a5bcdd] Plots v1.40.5\n [f517fe37] Polyester v0.7.15\n [1d0040c9] PolyesterWeave v0.2.2\n [2dfb63ee] PooledArrays v1.4.3\n [dd99e9e3] PowerFlowData v1.5.0\n [94fada2c] PowerFlows v0.7.0\n [bed98974] PowerNetworkMatrices v0.11.0\n [398b2ede] PowerSimulationsDynamics v0.15.0 `~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl`\n [f00506e0] PowerSystemCaseBuilder v1.3.3\n [bcd98974] PowerSystems v4.1.2\n [d236fae5] PreallocationTools v0.4.22\n [aea7be01] PrecompileTools v1.2.1\n [21216c6a] Preferences v1.4.3\n [08abe8d2] PrettyTables v2.3.2\n [33c8b6b6] ProgressLogging v0.1.4\n [3cdcf5f2] RecipesBase v1.3.4\n [01d81517] RecipesPipeline v0.6.12\n [731186ca] RecursiveArrayTools v3.26.0\n [f2c3362d] RecursiveFactorization v0.2.23\n [189a3867] Reexport v1.2.2\n [05181044] RelocatableFolders v1.0.1\n [ae029012] Requires v1.3.0\n [7e49a35a] RuntimeGeneratedFunctions v0.5.13\n [94e857df] SIMDTypes v0.1.0\n [476501e8] SLEEFPirates v0.6.43\n [0aa819cd] SQLite v1.6.1\n [322a6be2] Sass v0.2.0\n [0bca4576] SciMLBase v2.42.0\n [c0aeaf25] SciMLOperators v0.3.8\n [53ae85a6] SciMLStructures v1.4.1\n [6c6a2e73] Scratch v1.2.1\n [91c51154] SentinelArrays v1.4.5\n [efcf1570] Setfield v1.1.1\n [992d4aef] Showoff v1.0.3\n [777ac1f9] SimpleBufferStream v1.1.0\n [727e6d20] SimpleNonlinearSolve v1.10.1\n [699a6c99] SimpleTraits v0.9.4\n [ce78b400] SimpleUnPack v1.1.0\n [a2af1166] SortingAlgorithms v1.2.1\n [47a9eef4] SparseDiffTools v2.19.0\n [0a514795] SparseMatrixColorings v0.3.3\n [e56a9233] Sparspak v0.3.9\n [276daf66] SpecialFunctions v2.4.0\n [aedffcd0] Static v1.1.0\n [0d7ed370] StaticArrayInterface v1.5.1\n [90137ffa] StaticArrays v1.9.7\n [1e83bf80] StaticArraysCore v1.4.3\n [82ae8749] StatsAPI v1.7.0\n [2913bbd2] StatsBase v0.34.3\n [7792a7ef] StrideArraysCore v0.5.7\n [69024149] StringEncodings v0.3.7\n [892a3eda] StringManipulation v0.3.4\n [856f2bd8] StructTypes v1.10.0\n [c3572dad] Sundials v4.24.0\n [2efcf032] SymbolicIndexingInterface v0.3.26\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.24.2\n [a759f4b9] TimerOutputs v0.5.24\n [3bb67fe8] TranscodingStreams v0.11.0\n [d5829a12] TriangularSolve v0.2.1\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.4\n [1986cc42] Unitful v1.20.0\n [45397f5d] UnitfulLatexify v1.6.4\n [41fe7b60] Unzip v0.2.0\n [3d5dd08c] VectorizationBase v0.21.70\n [19fa3120] VertexSafeGraphs v0.2.0\n [ea10d353] WeakRefStrings v1.4.2\n [76eceee3] WorkerUtilities v1.6.1\n [ddb6d928] YAML v0.4.11\n [0b7ba130] Blosc_jll v1.21.5+0\n [6e34b625] Bzip2_jll v1.0.8+1\n [83423d85] Cairo_jll v1.18.0+2\n [2702e6a9] EpollShim_jll v0.0.20230411+0\n [2e619515] Expat_jll v2.6.2+0\n⌅ [b22a6f82] FFMPEG_jll v4.4.2+2\n [a3f928ae] Fontconfig_jll v2.13.96+0\n [d7e528f0] FreeType2_jll v2.13.2+0\n [559328eb] FriBidi_jll v1.0.14+0\n [0656b61e] GLFW_jll v3.4.0+0\n⌅ [d2c73de3] GR_jll v0.73.5+0\n [78b55507] Gettext_jll v0.21.0+0\n [7746bdde] Glib_jll v2.80.2+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 v2024.2.0+0\n [aacddb02] JpegTurbo_jll v3.0.3+0\n [c1c5ebd0] LAME_jll v3.100.2+0\n⌅ [88015f11] LERC_jll v3.0.0+1\n [1d63c593] LLVMOpenMP_jll v15.0.7+0\n [dd4b983a] LZO_jll v2.10.2+0\n⌅ [e9f186c6] Libffi_jll v3.2.2+1\n [d4300ac3] Libgcrypt_jll v1.8.11+0\n [7e76a0d4] Libglvnd_jll v1.6.0+0\n [7add5ba3] Libgpg_error_jll v1.49.0+0\n [94ce4f54] Libiconv_jll v1.17.0+0\n [4b2f31a3] Libmount_jll v2.40.1+0\n⌅ [89763e89] Libtiff_jll v4.5.1+1\n [38a345b3] Libuuid_jll v2.40.1+0\n [5ced341a] Lz4_jll v1.9.4+0\n [856f044c] MKL_jll v2024.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.43.4+0\n⌅ [c0090381] Qt6Base_jll v6.5.2+2\n [76ed43ae] SQLite_jll v3.45.3+0\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.13.1+0\n [aed1982a] XSLT_jll v1.1.41+0\n [ffd25f8a] XZ_jll v5.4.6+0\n [f67eecfb] Xorg_libICE_jll v1.1.1+0\n [c834827a] Xorg_libSM_jll v1.2.4+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.6+0\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.11+0\n [14d82f49] Xorg_libpthread_stubs_jll v0.1.1+0\n [c7cfdc94] Xorg_libxcb_jll v1.17.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.6+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.9.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.43+1\n [47bcb7c8] libsass_jll v3.6.6+0\n [f27f6e37] libvorbis_jll v1.3.7+1\n [009596ad] mtdev_jll v1.1.6+0\n [1317d2d5] oneTBB_jll v2021.12.0+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.1.1+0\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+4\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"},"time_series_in_memory":false},"units_settings":{"base_value":100.0,"unit_system":"SYSTEM_BASE","__metadata__":{"module":"InfrastructureSystems","type":"SystemUnitsSettings"}},"frequency":60.0,"runchecks":true,"metadata":{"name":null,"description":null,"__metadata__":{"module":"PowerSystems","type":"SystemMetadata"}},"data_format_version":"4.0.0"} \ No newline at end of file diff --git a/previews/PR385/tutorials/threebus_sys.json b/previews/PR385/tutorials/threebus_sys.json index 0f49f72bd..95f3fcf72 100644 --- a/previews/PR385/tutorials/threebus_sys.json +++ b/previews/PR385/tutorials/threebus_sys.json @@ -1 +1 @@ -{"internal":{"uuid":{"value":"502bb4b0-3933-401e-a8aa-f87c0436833e"},"ext":{},"units_info":null},"data":{"masked_components":[],"supplemental_attribute_manager":{"attributes":[],"associations":[]},"internal":{"uuid":{"value":"0f279ca9-7aa2-4895-8b6b-d92fc75aff5c"},"ext":{},"units_info":null},"time_series_compression_enabled":false,"components":[{"rating":2.5,"services":[],"x":0.12,"b":{"from":0.1,"to":0.1},"r":0.01,"available":true,"name":"BUS 1-BUS 3-i_1","reactive_power_flow":0.0,"arc":{"value":"ca02e2c8-1709-4f64-937f-26cd763f2e07"},"__metadata__":{"module":"PowerSystems","type":"Line"},"internal":{"uuid":{"value":"b07e49ec-006e-4a65-bd89-91b6515374fa"},"ext":null,"units_info":null},"ext":{},"active_power_flow":0.0,"angle_limits":{"min":-1.0472,"max":1.0472}},{"rating":2.5,"services":[],"x":0.12,"b":{"from":0.1,"to":0.1},"r":0.01,"available":true,"name":"BUS 1-BUS 2-i_1","reactive_power_flow":0.0,"arc":{"value":"68f916ed-7c53-47f5-90dd-c6f87f2b7582"},"__metadata__":{"module":"PowerSystems","type":"Line"},"internal":{"uuid":{"value":"3033067f-6253-4819-8db3-1502f9a21d7c"},"ext":null,"units_info":null},"ext":{},"active_power_flow":0.0,"angle_limits":{"min":-1.0472,"max":1.0472}},{"rating":2.5,"services":[],"x":0.9,"b":{"from":0.5,"to":0.5},"r":0.02,"available":true,"name":"BUS 2-BUS 3-i_1","reactive_power_flow":0.0,"arc":{"value":"4bb470af-3266-4db3-af4c-abfade6e3e0f"},"__metadata__":{"module":"PowerSystems","type":"Line"},"internal":{"uuid":{"value":"c7d33fa3-73d1-4fbd-bdcb-62b8a2a1a25f"},"ext":null,"units_info":null},"ext":{},"active_power_flow":0.0,"angle_limits":{"min":-1.0472,"max":1.0472}},{"base_power":100.0,"prime_mover_type":"OT","rating":3.333526661060325,"services":[],"bus":{"value":"5455f2b0-c66c-486e-b06a-b17f252d94dc"},"available":true,"name":"generator-102-1","status":true,"active_power":0.7,"dynamic_injector":{"value":"127468fd-6a65-41cc-a538-0c09b66e545c"},"__metadata__":{"module":"PowerSystems","type":"ThermalStandard"},"fuel":"OTHER","internal":{"uuid":{"value":"56d8f095-0e6b-4e20-88b4-e2606bbcb5be"},"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":{"__metadata__":{"parameters":["InputOutputCurve"],"module":"PowerSystems","type":"CostCurve"},"value_curve":{"input_at_zero":null,"function_data":{"__metadata__":{"module":"InfrastructureSystems","type":"QuadraticFunctionData"},"quadratic_term":0.0,"constant_term":0.0,"proportional_term":1.0},"__metadata__":{"parameters":["QuadraticFunctionData"],"module":"PowerSystems","type":"InputOutputCurve"}},"power_units":"DEVICE_BASE","vom_cost":{"input_at_zero":null,"function_data":{"__metadata__":{"module":"InfrastructureSystems","type":"LinearFunctionData"},"constant_term":0.0,"proportional_term":0.0},"__metadata__":{"parameters":["LinearFunctionData"],"module":"PowerSystems","type":"InputOutputCurve"}}},"__metadata__":{"module":"PowerSystems","type":"ThermalGenerationCost"}},"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":"a66f4d5b-f314-4a7b-a0db-8b3161596693"},"available":true,"name":"generator-103-1","status":true,"active_power":0.8,"dynamic_injector":{"value":"31b2a2a9-33ce-44e7-b26d-28d3cc8352c5"},"__metadata__":{"module":"PowerSystems","type":"ThermalStandard"},"fuel":"OTHER","internal":{"uuid":{"value":"1c86def4-b6b9-4eaf-9c4a-851e8fbac733"},"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":{"__metadata__":{"parameters":["InputOutputCurve"],"module":"PowerSystems","type":"CostCurve"},"value_curve":{"input_at_zero":null,"function_data":{"__metadata__":{"module":"InfrastructureSystems","type":"QuadraticFunctionData"},"quadratic_term":0.0,"constant_term":0.0,"proportional_term":1.0},"__metadata__":{"parameters":["QuadraticFunctionData"],"module":"PowerSystems","type":"InputOutputCurve"}},"power_units":"DEVICE_BASE","vom_cost":{"input_at_zero":null,"function_data":{"__metadata__":{"module":"InfrastructureSystems","type":"LinearFunctionData"},"constant_term":0.0,"proportional_term":0.0},"__metadata__":{"parameters":["LinearFunctionData"],"module":"PowerSystems","type":"InputOutputCurve"}}},"__metadata__":{"module":"PowerSystems","type":"ThermalGenerationCost"}},"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":"216fc5d6-be34-4093-abaa-4e79cec1e1cc"},"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":"f8525c75-2337-4e5f-9399-a14e05fb4c79"},"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":"127468fd-6a65-41cc-a538-0c09b66e545c"},"ext":null,"units_info":null},"ext":{},"machine":{"internal":{"uuid":{"value":"5661c1e8-c3e1-4920-9249-1a190afed990"},"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":"240802a2-6062-443e-8b45-4f6d4570c4f9"},"ext":null,"units_info":null},"n_states":0,"ext":{},"states":[],"__metadata__":{"module":"PowerSystems","type":"PSSFixed"}},"prime_mover":{"P_ref":1.0,"internal":{"uuid":{"value":"83514fc9-4544-4ec4-8f4d-b2c48c504317"},"ext":null,"units_info":null},"efficiency":1.0,"n_states":0,"ext":{},"states":[],"__metadata__":{"module":"PowerSystems","type":"TGFixed"}}},{"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":"6f829d25-a35b-46b2-8b5c-90cbef73546f"},"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":"31b2a2a9-33ce-44e7-b26d-28d3cc8352c5"},"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},{"load_response":0.0,"name":"1","internal":{"uuid":{"value":"8fd456ad-86d1-4d71-8bca-5a784a5af76e"},"ext":null,"units_info":null},"ext":{},"peak_active_power":0.0,"peak_reactive_power":0.0,"__metadata__":{"module":"PowerSystems","type":"Area"}},{"base_power":100.0,"services":[],"bus":{"value":"633ca24d-6567-400e-b37e-a056afc87728"},"max_constant_active_power":0.5,"available":true,"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":"9ccaf330-0ebb-4611-a816-267d2787a997"},"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":"a66f4d5b-f314-4a7b-a0db-8b3161596693"},"max_constant_active_power":0.3,"available":true,"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":"cbaaefb1-31bc-4bfb-9870-654ac0511be4"},"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":"5455f2b0-c66c-486e-b06a-b17f252d94dc"},"max_constant_active_power":1.0,"available":true,"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":"13f6e537-49c2-4c4f-b1d6-def9cf8106bf"},"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},{"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":"a66f4d5b-f314-4a7b-a0db-8b3161596693"},"ext":null,"units_info":null},"area":{"value":"8fd456ad-86d1-4d71-8bca-5a784a5af76e"},"ext":{},"voltage_limits":{"min":0.9,"max":1.1},"load_zone":{"value":"0d1f0e06-4d12-483a-ac17-6be9401346d7"}},{"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":"633ca24d-6567-400e-b37e-a056afc87728"},"ext":null,"units_info":null},"area":{"value":"8fd456ad-86d1-4d71-8bca-5a784a5af76e"},"ext":{},"voltage_limits":{"min":0.9,"max":1.1},"load_zone":{"value":"0d1f0e06-4d12-483a-ac17-6be9401346d7"}},{"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":"5455f2b0-c66c-486e-b06a-b17f252d94dc"},"ext":null,"units_info":null},"area":{"value":"8fd456ad-86d1-4d71-8bca-5a784a5af76e"},"ext":{},"voltage_limits":{"min":0.9,"max":1.1},"load_zone":{"value":"0d1f0e06-4d12-483a-ac17-6be9401346d7"}},{"name":"1","internal":{"uuid":{"value":"0d1f0e06-4d12-483a-ac17-6be9401346d7"},"ext":null,"units_info":null},"ext":{},"peak_active_power":1.8,"peak_reactive_power":0.5,"__metadata__":{"module":"PowerSystems","type":"LoadZone"}},{"internal":{"uuid":{"value":"ca02e2c8-1709-4f64-937f-26cd763f2e07"},"ext":null,"units_info":null},"to":{"value":"a66f4d5b-f314-4a7b-a0db-8b3161596693"},"from":{"value":"633ca24d-6567-400e-b37e-a056afc87728"},"__metadata__":{"module":"PowerSystems","type":"Arc"}},{"internal":{"uuid":{"value":"68f916ed-7c53-47f5-90dd-c6f87f2b7582"},"ext":null,"units_info":null},"to":{"value":"5455f2b0-c66c-486e-b06a-b17f252d94dc"},"from":{"value":"633ca24d-6567-400e-b37e-a056afc87728"},"__metadata__":{"module":"PowerSystems","type":"Arc"}},{"internal":{"uuid":{"value":"4bb470af-3266-4db3-af4c-abfade6e3e0f"},"ext":null,"units_info":null},"to":{"value":"a66f4d5b-f314-4a7b-a0db-8b3161596693"},"from":{"value":"5455f2b0-c66c-486e-b06a-b17f252d94dc"},"__metadata__":{"module":"PowerSystems","type":"Arc"}}],"subsystems":{},"version_info":{"julia_version":"1.10.4","package_info":"Status `~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/docs/Manifest.toml`\n [47edcb42] ADTypes v1.5.3\n [a4c015fc] ANSIColoredPrinters v0.0.1\n [1520ce14] AbstractTrees v0.4.5\n [7d9f7c33] Accessors v0.1.36\n [79e6a3ab] Adapt v4.0.4\n [ec485272] ArnoldiMethod v0.4.0\n [4fba245c] ArrayInterface v7.12.0\n [4c555306] ArrayLayouts v1.10.2\n [d1d4a3ce] BitFlags v0.1.9\n [62783981] BitTwiddlingConvenienceFunctions v0.1.6\n [a74b3585] Blosc v0.7.3\n [fa961155] CEnum v0.5.0\n [2a0fbf3d] CPUSummary v0.2.6\n [336ed68f] CSV v0.10.14\n [d360d2e6] ChainRulesCore v1.24.0\n [fb6a15b2] CloseOpenIntervals v0.1.13\n [944b1d66] CodecZlib v0.7.5\n [35d6a980] ColorSchemes v3.25.0\n [3da002f7] ColorTypes v0.11.5\n [c3611d14] ColorVectorSpace v0.10.0\n [5ae59095] Colors v0.12.11\n [38540f10] CommonSolve v0.2.4\n [bbf7d656] CommonSubexpressions v0.3.0\n [f70d9fcc] CommonWorldInvalidations v1.0.0\n [34da2185] Compat v4.15.0\n [a33af91c] CompositionsBase v0.1.2\n [2569d6c7] ConcreteStructs v0.2.3\n [f0e56b4a] ConcurrentUtilities v2.4.2\n [187b0558] ConstructionBase v1.5.5\n [d38c429a] Contour v0.6.3\n [adafc99b] CpuId v0.3.1\n [a8cc5b0e] Crayons v4.1.1\n [a10d1c49] DBInterface v2.6.1\n [9a962f9c] DataAPI v1.16.0\n [a93c6f00] DataFrames v1.6.1\n [864edb3b] DataStructures v0.18.20\n [e2d170a0] DataValueInterfaces v1.0.0\n [8bb1440f] DelimitedFiles v1.9.1\n [2b5f629d] DiffEqBase v6.151.5\n [163ba53b] DiffResults v1.1.0\n [b552c78f] DiffRules v1.15.1\n [a0c0ee7d] DifferentiationInterface v0.5.7\n [b4f34e82] Distances v0.10.11\n [ffbed154] DocStringExtensions v0.9.3\n⌅ [e30172f5] Documenter v0.27.25\n [35a29f4d] DocumenterTools v0.1.19\n [4e289a0a] EnumX v1.0.4\n [f151be2c] EnzymeCore v0.7.6\n [460bff9d] ExceptionUnwrapping v0.1.10\n [d4d017d3] ExponentialUtilities v1.26.1\n [e2ba6199] ExprTools v0.1.10\n [c87230d0] FFMPEG v0.4.1\n [7034ab61] FastBroadcast v0.3.4\n [9aa1b823] FastClosures v0.3.2\n [29a986be] FastLapackInterface v2.0.4\n [48062228] FilePathsBase v0.9.21\n [1a297f60] FillArrays v1.11.0\n [6a86dc24] FiniteDiff v2.23.1\n [53c48c17] FixedPointNumbers v0.8.5\n [1fa38f19] Format v1.3.7\n [f6369f11] ForwardDiff v0.10.36\n [069b7b12] FunctionWrappers v1.1.3\n [77dc65aa] FunctionWrappersWrappers v0.1.3\n [46192b85] GPUArraysCore v0.1.6\n⌃ [28b8d3ca] GR v0.73.5\n [c145ed77] GenericSchur v0.5.4\n [86223c79] Graphs v1.11.2\n [42e2da0e] Grisu v1.0.2\n [708ec375] Gumbo v0.8.2\n [c8ec2601] H5Zblosc v0.1.2\n [f67ccb44] HDF5 v0.17.2\n [cd3eb016] HTTP v1.10.8\n [3e5b6fbb] HostCPUFeatures v0.1.17\n [b5f81e59] IOCapture v0.2.5\n [615f187c] IfElse v0.1.1\n [d25df0c9] Inflate v0.1.5\n [2cd47ed4] InfrastructureSystems v2.0.2\n [842dd82b] InlineStrings v1.4.1\n [3587e190] InverseFunctions v0.1.14\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.6.0\n [ba0b0d4f] Krylov v0.9.6\n [b964fa9f] LaTeXStrings v1.3.1\n [23fbe1c1] Latexify v0.16.4\n [10f19ff3] LayoutPointers v0.1.17\n [5078a376] LazyArrays v2.1.7\n [1d6d02ad] LeftChildRightSiblingTrees v0.2.0\n [d3d80556] LineSearches v7.2.0\n [7ed4a6bd] LinearSolve v2.30.2\n [2ab3a3ac] LogExpFunctions v0.3.28\n [e6f89c97] LoggingExtras v1.0.3\n [bdcacae8] LoopVectorization v0.12.171\n⌅ [33e6dc65] MKL v0.6.3\n [3da0fdf6] MPIPreferences v0.1.11\n [1914dd2f] MacroTools v0.5.13\n [d125e4d3] ManualMemory v0.1.8\n [299715c1] MarchingCubes v0.1.9\n [bb5d69b7] MaybeInplace v0.1.3\n [739be429] MbedTLS v1.1.9\n [442fdcdd] Measures v0.3.2\n [e1d29d7a] Missings v1.2.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.13.1\n [6fe1bfb0] OffsetArrays v1.14.1\n [4d8831e6] OpenSSL v1.4.3\n [bac558e1] OrderedCollections v1.6.3\n [1dea7af3] OrdinaryDiffEq v6.85.0\n [65ce6f38] PackageExtensionCompat v1.0.2\n [d96e819e] Parameters v0.12.3\n [46dd5b70] Pardiso v0.5.7\n [69de0a69] Parsers v2.8.1\n [b98c9c47] Pipe v1.3.0\n [ccf2f8ad] PlotThemes v3.2.0\n [995b91a9] PlotUtils v1.4.1\n [91a5bcdd] Plots v1.40.5\n [f517fe37] Polyester v0.7.15\n [1d0040c9] PolyesterWeave v0.2.2\n [2dfb63ee] PooledArrays v1.4.3\n [dd99e9e3] PowerFlowData v1.5.0\n [94fada2c] PowerFlows v0.7.0\n [bed98974] PowerNetworkMatrices v0.11.0\n [398b2ede] PowerSimulationsDynamics v0.15.0 `~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl`\n [f00506e0] PowerSystemCaseBuilder v1.3.3\n [bcd98974] PowerSystems v4.1.2\n [d236fae5] PreallocationTools v0.4.22\n [aea7be01] PrecompileTools v1.2.1\n [21216c6a] Preferences v1.4.3\n [08abe8d2] PrettyTables v2.3.2\n [33c8b6b6] ProgressLogging v0.1.4\n [3cdcf5f2] RecipesBase v1.3.4\n [01d81517] RecipesPipeline v0.6.12\n [731186ca] RecursiveArrayTools v3.26.0\n [f2c3362d] RecursiveFactorization v0.2.23\n [189a3867] Reexport v1.2.2\n [05181044] RelocatableFolders v1.0.1\n [ae029012] Requires v1.3.0\n [7e49a35a] RuntimeGeneratedFunctions v0.5.13\n [94e857df] SIMDTypes v0.1.0\n [476501e8] SLEEFPirates v0.6.43\n [0aa819cd] SQLite v1.6.1\n [322a6be2] Sass v0.2.0\n [0bca4576] SciMLBase v2.42.0\n [c0aeaf25] SciMLOperators v0.3.8\n [53ae85a6] SciMLStructures v1.4.1\n [6c6a2e73] Scratch v1.2.1\n [91c51154] SentinelArrays v1.4.5\n [efcf1570] Setfield v1.1.1\n [992d4aef] Showoff v1.0.3\n [777ac1f9] SimpleBufferStream v1.1.0\n [727e6d20] SimpleNonlinearSolve v1.10.1\n [699a6c99] SimpleTraits v0.9.4\n [ce78b400] SimpleUnPack v1.1.0\n [a2af1166] SortingAlgorithms v1.2.1\n [47a9eef4] SparseDiffTools v2.19.0\n [0a514795] SparseMatrixColorings v0.3.3\n [e56a9233] Sparspak v0.3.9\n [276daf66] SpecialFunctions v2.4.0\n [aedffcd0] Static v1.1.0\n [0d7ed370] StaticArrayInterface v1.5.1\n [90137ffa] StaticArrays v1.9.7\n [1e83bf80] StaticArraysCore v1.4.3\n [82ae8749] StatsAPI v1.7.0\n [2913bbd2] StatsBase v0.34.3\n [7792a7ef] StrideArraysCore v0.5.7\n [69024149] StringEncodings v0.3.7\n [892a3eda] StringManipulation v0.3.4\n [856f2bd8] StructTypes v1.10.0\n [c3572dad] Sundials v4.24.0\n [2efcf032] SymbolicIndexingInterface v0.3.26\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.24.2\n [a759f4b9] TimerOutputs v0.5.24\n [3bb67fe8] TranscodingStreams v0.11.0\n [d5829a12] TriangularSolve v0.2.1\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.4\n [1986cc42] Unitful v1.20.0\n [45397f5d] UnitfulLatexify v1.6.4\n [41fe7b60] Unzip v0.2.0\n [3d5dd08c] VectorizationBase v0.21.70\n [19fa3120] VertexSafeGraphs v0.2.0\n [ea10d353] WeakRefStrings v1.4.2\n [76eceee3] WorkerUtilities v1.6.1\n [ddb6d928] YAML v0.4.11\n [0b7ba130] Blosc_jll v1.21.5+0\n [6e34b625] Bzip2_jll v1.0.8+1\n [83423d85] Cairo_jll v1.18.0+2\n [2702e6a9] EpollShim_jll v0.0.20230411+0\n [2e619515] Expat_jll v2.6.2+0\n⌅ [b22a6f82] FFMPEG_jll v4.4.2+2\n [a3f928ae] Fontconfig_jll v2.13.96+0\n [d7e528f0] FreeType2_jll v2.13.2+0\n [559328eb] FriBidi_jll v1.0.14+0\n [0656b61e] GLFW_jll v3.4.0+0\n⌅ [d2c73de3] GR_jll v0.73.5+0\n [78b55507] Gettext_jll v0.21.0+0\n [7746bdde] Glib_jll v2.80.2+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 v2024.2.0+0\n [aacddb02] JpegTurbo_jll v3.0.3+0\n [c1c5ebd0] LAME_jll v3.100.2+0\n⌅ [88015f11] LERC_jll v3.0.0+1\n [1d63c593] LLVMOpenMP_jll v15.0.7+0\n [dd4b983a] LZO_jll v2.10.2+0\n⌅ [e9f186c6] Libffi_jll v3.2.2+1\n [d4300ac3] Libgcrypt_jll v1.8.11+0\n [7e76a0d4] Libglvnd_jll v1.6.0+0\n [7add5ba3] Libgpg_error_jll v1.49.0+0\n [94ce4f54] Libiconv_jll v1.17.0+0\n [4b2f31a3] Libmount_jll v2.40.1+0\n⌅ [89763e89] Libtiff_jll v4.5.1+1\n [38a345b3] Libuuid_jll v2.40.1+0\n [5ced341a] Lz4_jll v1.9.4+0\n [856f044c] MKL_jll v2024.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.43.4+0\n⌅ [c0090381] Qt6Base_jll v6.5.2+2\n [76ed43ae] SQLite_jll v3.45.3+0\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.13.1+0\n [aed1982a] XSLT_jll v1.1.41+0\n [ffd25f8a] XZ_jll v5.4.6+0\n [f67eecfb] Xorg_libICE_jll v1.1.1+0\n [c834827a] Xorg_libSM_jll v1.2.4+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.6+0\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.11+0\n [14d82f49] Xorg_libpthread_stubs_jll v0.1.1+0\n [c7cfdc94] Xorg_libxcb_jll v1.17.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.6+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.9.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.43+1\n [47bcb7c8] libsass_jll v3.6.6+0\n [f27f6e37] libvorbis_jll v1.3.7+1\n [009596ad] mtdev_jll v1.1.6+0\n [1317d2d5] oneTBB_jll v2021.12.0+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.1.1+0\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+4\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"},"time_series_in_memory":false},"units_settings":{"base_value":100.0,"unit_system":"SYSTEM_BASE","__metadata__":{"module":"InfrastructureSystems","type":"SystemUnitsSettings"}},"frequency":60.0,"runchecks":true,"metadata":{"name":null,"description":null,"__metadata__":{"module":"PowerSystems","type":"SystemMetadata"}},"data_format_version":"4.0.0"} \ No newline at end of file +{"internal":{"uuid":{"value":"54253cda-9c46-4c98-9feb-b11d2d9a2c6e"},"ext":{},"units_info":null},"data":{"masked_components":[],"supplemental_attribute_manager":{"attributes":[],"associations":[]},"internal":{"uuid":{"value":"514bdf9e-2bd7-40bb-a2a3-0e7a676ab21d"},"ext":{},"units_info":null},"time_series_compression_enabled":false,"components":[{"name":"1","internal":{"uuid":{"value":"76d5a564-f87b-476f-9568-0ff8f0bb30a5"},"ext":null,"units_info":null},"ext":{},"peak_active_power":1.8,"peak_reactive_power":0.5,"__metadata__":{"module":"PowerSystems","type":"LoadZone"}},{"base_power":100.0,"shaft":{"internal":{"uuid":{"value":"dd9ba027-5f0d-48da-8457-0cf037fbaabf"},"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":"4614878a-27a7-4586-a877-3e1ee8e7f889"},"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":"f167e241-bee5-4528-a1cb-bb6f11ca26ac"},"ext":null,"units_info":null},"ext":{},"machine":{"internal":{"uuid":{"value":"f3c14bb8-bb33-497c-9c86-cf42c9eb19af"},"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":"697e8b97-724c-4bf7-9440-21afaba12071"},"ext":null,"units_info":null},"n_states":0,"ext":{},"states":[],"__metadata__":{"module":"PowerSystems","type":"PSSFixed"}},"prime_mover":{"P_ref":1.0,"internal":{"uuid":{"value":"e7c2efa5-dda1-4223-be64-51c5e3675b7e"},"ext":null,"units_info":null},"efficiency":1.0,"n_states":0,"ext":{},"states":[],"__metadata__":{"module":"PowerSystems","type":"TGFixed"}}},{"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":"d8b8832e-3112-43e8-9f7d-66feef9fa778"},"ext":null,"units_info":null},"area":{"value":"0657d78c-8044-486e-ba68-8bb2f8f18c15"},"ext":{},"voltage_limits":{"min":0.9,"max":1.1},"load_zone":{"value":"76d5a564-f87b-476f-9568-0ff8f0bb30a5"}},{"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":"15b454a0-d292-4fbf-8dbe-ea5999b03cd5"},"ext":null,"units_info":null},"area":{"value":"0657d78c-8044-486e-ba68-8bb2f8f18c15"},"ext":{},"voltage_limits":{"min":0.9,"max":1.1},"load_zone":{"value":"76d5a564-f87b-476f-9568-0ff8f0bb30a5"}},{"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":"7bef6f94-7532-41b7-9a6e-7a64b24524c2"},"ext":null,"units_info":null},"area":{"value":"0657d78c-8044-486e-ba68-8bb2f8f18c15"},"ext":{},"voltage_limits":{"min":0.9,"max":1.1},"load_zone":{"value":"76d5a564-f87b-476f-9568-0ff8f0bb30a5"}},{"internal":{"uuid":{"value":"e6b1f83e-461d-4125-b8b5-1c28ea47e6b1"},"ext":null,"units_info":null},"to":{"value":"d8b8832e-3112-43e8-9f7d-66feef9fa778"},"from":{"value":"15b454a0-d292-4fbf-8dbe-ea5999b03cd5"},"__metadata__":{"module":"PowerSystems","type":"Arc"}},{"internal":{"uuid":{"value":"60573a02-634d-4b33-9da0-be9d021c6324"},"ext":null,"units_info":null},"to":{"value":"7bef6f94-7532-41b7-9a6e-7a64b24524c2"},"from":{"value":"15b454a0-d292-4fbf-8dbe-ea5999b03cd5"},"__metadata__":{"module":"PowerSystems","type":"Arc"}},{"internal":{"uuid":{"value":"6edd0ec3-bd6b-4091-a4c3-b85057c54295"},"ext":null,"units_info":null},"to":{"value":"d8b8832e-3112-43e8-9f7d-66feef9fa778"},"from":{"value":"7bef6f94-7532-41b7-9a6e-7a64b24524c2"},"__metadata__":{"module":"PowerSystems","type":"Arc"}},{"base_power":100.0,"services":[],"bus":{"value":"15b454a0-d292-4fbf-8dbe-ea5999b03cd5"},"max_constant_active_power":0.5,"available":true,"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":"389ecdbf-4160-4420-9776-15b2fc16c91c"},"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":"d8b8832e-3112-43e8-9f7d-66feef9fa778"},"max_constant_active_power":0.3,"available":true,"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":"01e608f5-05a6-48d0-bdab-5c19394f8b6e"},"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":"7bef6f94-7532-41b7-9a6e-7a64b24524c2"},"max_constant_active_power":1.0,"available":true,"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":"41b75085-badd-451e-a863-9f08885d2577"},"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},{"load_response":0.0,"name":"1","internal":{"uuid":{"value":"0657d78c-8044-486e-ba68-8bb2f8f18c15"},"ext":null,"units_info":null},"ext":{},"peak_active_power":0.0,"peak_reactive_power":0.0,"__metadata__":{"module":"PowerSystems","type":"Area"}},{"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":"f4e0cd1c-0e65-4434-b471-8bc679f05f80"},"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":"dee1d673-ea85-40f8-9ef1-9cd5097939b4"},"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},{"rating":2.5,"services":[],"x":0.12,"b":{"from":0.1,"to":0.1},"r":0.01,"available":true,"name":"BUS 1-BUS 3-i_1","reactive_power_flow":0.0,"arc":{"value":"e6b1f83e-461d-4125-b8b5-1c28ea47e6b1"},"__metadata__":{"module":"PowerSystems","type":"Line"},"internal":{"uuid":{"value":"7cf012a1-909a-4e3f-a14d-2e636c49b3c7"},"ext":null,"units_info":null},"ext":{},"active_power_flow":0.0,"angle_limits":{"min":-1.0472,"max":1.0472}},{"rating":2.5,"services":[],"x":0.12,"b":{"from":0.1,"to":0.1},"r":0.01,"available":true,"name":"BUS 1-BUS 2-i_1","reactive_power_flow":0.0,"arc":{"value":"60573a02-634d-4b33-9da0-be9d021c6324"},"__metadata__":{"module":"PowerSystems","type":"Line"},"internal":{"uuid":{"value":"6a262e5c-ea4a-4622-b9b7-cdb2450fd20e"},"ext":null,"units_info":null},"ext":{},"active_power_flow":0.0,"angle_limits":{"min":-1.0472,"max":1.0472}},{"rating":2.5,"services":[],"x":0.9,"b":{"from":0.5,"to":0.5},"r":0.02,"available":true,"name":"BUS 2-BUS 3-i_1","reactive_power_flow":0.0,"arc":{"value":"6edd0ec3-bd6b-4091-a4c3-b85057c54295"},"__metadata__":{"module":"PowerSystems","type":"Line"},"internal":{"uuid":{"value":"ead04ec7-a1b6-474e-a598-57c2f310dfb9"},"ext":null,"units_info":null},"ext":{},"active_power_flow":0.0,"angle_limits":{"min":-1.0472,"max":1.0472}},{"base_power":100.0,"prime_mover_type":"OT","rating":3.333526661060325,"services":[],"bus":{"value":"7bef6f94-7532-41b7-9a6e-7a64b24524c2"},"available":true,"name":"generator-102-1","status":true,"active_power":0.7,"dynamic_injector":{"value":"f167e241-bee5-4528-a1cb-bb6f11ca26ac"},"__metadata__":{"module":"PowerSystems","type":"ThermalStandard"},"fuel":"OTHER","internal":{"uuid":{"value":"c0d77bfb-336b-4630-8890-e07f72aca664"},"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":{"__metadata__":{"parameters":["InputOutputCurve"],"module":"PowerSystems","type":"CostCurve"},"value_curve":{"input_at_zero":null,"function_data":{"__metadata__":{"module":"InfrastructureSystems","type":"QuadraticFunctionData"},"quadratic_term":0.0,"constant_term":0.0,"proportional_term":1.0},"__metadata__":{"parameters":["QuadraticFunctionData"],"module":"PowerSystems","type":"InputOutputCurve"}},"power_units":"DEVICE_BASE","vom_cost":{"input_at_zero":null,"function_data":{"__metadata__":{"module":"InfrastructureSystems","type":"LinearFunctionData"},"constant_term":0.0,"proportional_term":0.0},"__metadata__":{"parameters":["LinearFunctionData"],"module":"PowerSystems","type":"InputOutputCurve"}}},"__metadata__":{"module":"PowerSystems","type":"ThermalGenerationCost"}},"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":"d8b8832e-3112-43e8-9f7d-66feef9fa778"},"available":true,"name":"generator-103-1","status":true,"active_power":0.8,"dynamic_injector":{"value":"dee1d673-ea85-40f8-9ef1-9cd5097939b4"},"__metadata__":{"module":"PowerSystems","type":"ThermalStandard"},"fuel":"OTHER","internal":{"uuid":{"value":"026e4998-e54a-4d0a-ac46-241682474a16"},"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":{"__metadata__":{"parameters":["InputOutputCurve"],"module":"PowerSystems","type":"CostCurve"},"value_curve":{"input_at_zero":null,"function_data":{"__metadata__":{"module":"InfrastructureSystems","type":"QuadraticFunctionData"},"quadratic_term":0.0,"constant_term":0.0,"proportional_term":1.0},"__metadata__":{"parameters":["QuadraticFunctionData"],"module":"PowerSystems","type":"InputOutputCurve"}},"power_units":"DEVICE_BASE","vom_cost":{"input_at_zero":null,"function_data":{"__metadata__":{"module":"InfrastructureSystems","type":"LinearFunctionData"},"constant_term":0.0,"proportional_term":0.0},"__metadata__":{"parameters":["LinearFunctionData"],"module":"PowerSystems","type":"InputOutputCurve"}}},"__metadata__":{"module":"PowerSystems","type":"ThermalGenerationCost"}},"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}],"subsystems":{},"version_info":{"julia_version":"1.10.4","package_info":"Status `~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl/docs/Manifest.toml`\n [47edcb42] ADTypes v1.5.3\n [a4c015fc] ANSIColoredPrinters v0.0.1\n [1520ce14] AbstractTrees v0.4.5\n [7d9f7c33] Accessors v0.1.36\n [79e6a3ab] Adapt v4.0.4\n [ec485272] ArnoldiMethod v0.4.0\n [4fba245c] ArrayInterface v7.12.0\n [4c555306] ArrayLayouts v1.10.2\n [d1d4a3ce] BitFlags v0.1.9\n [62783981] BitTwiddlingConvenienceFunctions v0.1.6\n [a74b3585] Blosc v0.7.3\n [fa961155] CEnum v0.5.0\n [2a0fbf3d] CPUSummary v0.2.6\n [336ed68f] CSV v0.10.14\n [d360d2e6] ChainRulesCore v1.24.0\n [fb6a15b2] CloseOpenIntervals v0.1.13\n [944b1d66] CodecZlib v0.7.5\n [35d6a980] ColorSchemes v3.25.0\n [3da002f7] ColorTypes v0.11.5\n [c3611d14] ColorVectorSpace v0.10.0\n [5ae59095] Colors v0.12.11\n [38540f10] CommonSolve v0.2.4\n [bbf7d656] CommonSubexpressions v0.3.0\n [f70d9fcc] CommonWorldInvalidations v1.0.0\n [34da2185] Compat v4.15.0\n [a33af91c] CompositionsBase v0.1.2\n [2569d6c7] ConcreteStructs v0.2.3\n [f0e56b4a] ConcurrentUtilities v2.4.2\n [187b0558] ConstructionBase v1.5.5\n [d38c429a] Contour v0.6.3\n [adafc99b] CpuId v0.3.1\n [a8cc5b0e] Crayons v4.1.1\n [a10d1c49] DBInterface v2.6.1\n [9a962f9c] DataAPI v1.16.0\n [a93c6f00] DataFrames v1.6.1\n [864edb3b] DataStructures v0.18.20\n [e2d170a0] DataValueInterfaces v1.0.0\n [8bb1440f] DelimitedFiles v1.9.1\n [2b5f629d] DiffEqBase v6.151.5\n [163ba53b] DiffResults v1.1.0\n [b552c78f] DiffRules v1.15.1\n [a0c0ee7d] DifferentiationInterface v0.5.7\n [b4f34e82] Distances v0.10.11\n [ffbed154] DocStringExtensions v0.9.3\n⌅ [e30172f5] Documenter v0.27.25\n [35a29f4d] DocumenterTools v0.1.19\n [4e289a0a] EnumX v1.0.4\n [f151be2c] EnzymeCore v0.7.6\n [460bff9d] ExceptionUnwrapping v0.1.10\n [d4d017d3] ExponentialUtilities v1.26.1\n [e2ba6199] ExprTools v0.1.10\n [c87230d0] FFMPEG v0.4.1\n [7034ab61] FastBroadcast v0.3.4\n [9aa1b823] FastClosures v0.3.2\n [29a986be] FastLapackInterface v2.0.4\n [48062228] FilePathsBase v0.9.21\n [1a297f60] FillArrays v1.11.0\n [6a86dc24] FiniteDiff v2.23.1\n [53c48c17] FixedPointNumbers v0.8.5\n [1fa38f19] Format v1.3.7\n [f6369f11] ForwardDiff v0.10.36\n [069b7b12] FunctionWrappers v1.1.3\n [77dc65aa] FunctionWrappersWrappers v0.1.3\n [46192b85] GPUArraysCore v0.1.6\n⌃ [28b8d3ca] GR v0.73.5\n [c145ed77] GenericSchur v0.5.4\n [86223c79] Graphs v1.11.2\n [42e2da0e] Grisu v1.0.2\n [708ec375] Gumbo v0.8.2\n [c8ec2601] H5Zblosc v0.1.2\n [f67ccb44] HDF5 v0.17.2\n [cd3eb016] HTTP v1.10.8\n [3e5b6fbb] HostCPUFeatures v0.1.17\n [b5f81e59] IOCapture v0.2.5\n [615f187c] IfElse v0.1.1\n [d25df0c9] Inflate v0.1.5\n [2cd47ed4] InfrastructureSystems v2.0.2\n [842dd82b] InlineStrings v1.4.1\n [3587e190] InverseFunctions v0.1.14\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.6.0\n [ba0b0d4f] Krylov v0.9.6\n [b964fa9f] LaTeXStrings v1.3.1\n [23fbe1c1] Latexify v0.16.4\n [10f19ff3] LayoutPointers v0.1.17\n [5078a376] LazyArrays v2.1.7\n [1d6d02ad] LeftChildRightSiblingTrees v0.2.0\n [d3d80556] LineSearches v7.2.0\n [7ed4a6bd] LinearSolve v2.30.2\n [2ab3a3ac] LogExpFunctions v0.3.28\n [e6f89c97] LoggingExtras v1.0.3\n [bdcacae8] LoopVectorization v0.12.171\n⌅ [33e6dc65] MKL v0.6.3\n [3da0fdf6] MPIPreferences v0.1.11\n [1914dd2f] MacroTools v0.5.13\n [d125e4d3] ManualMemory v0.1.8\n [299715c1] MarchingCubes v0.1.9\n [bb5d69b7] MaybeInplace v0.1.3\n [739be429] MbedTLS v1.1.9\n [442fdcdd] Measures v0.3.2\n [e1d29d7a] Missings v1.2.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.13.1\n [6fe1bfb0] OffsetArrays v1.14.1\n [4d8831e6] OpenSSL v1.4.3\n [bac558e1] OrderedCollections v1.6.3\n [1dea7af3] OrdinaryDiffEq v6.85.0\n [65ce6f38] PackageExtensionCompat v1.0.2\n [d96e819e] Parameters v0.12.3\n [46dd5b70] Pardiso v0.5.7\n [69de0a69] Parsers v2.8.1\n [b98c9c47] Pipe v1.3.0\n [ccf2f8ad] PlotThemes v3.2.0\n [995b91a9] PlotUtils v1.4.1\n [91a5bcdd] Plots v1.40.5\n [f517fe37] Polyester v0.7.15\n [1d0040c9] PolyesterWeave v0.2.2\n [2dfb63ee] PooledArrays v1.4.3\n [dd99e9e3] PowerFlowData v1.5.0\n [94fada2c] PowerFlows v0.7.0\n [bed98974] PowerNetworkMatrices v0.11.0\n [398b2ede] PowerSimulationsDynamics v0.15.0 `~/work/PowerSimulationsDynamics.jl/PowerSimulationsDynamics.jl`\n [f00506e0] PowerSystemCaseBuilder v1.3.3\n [bcd98974] PowerSystems v4.1.2\n [d236fae5] PreallocationTools v0.4.22\n [aea7be01] PrecompileTools v1.2.1\n [21216c6a] Preferences v1.4.3\n [08abe8d2] PrettyTables v2.3.2\n [33c8b6b6] ProgressLogging v0.1.4\n [3cdcf5f2] RecipesBase v1.3.4\n [01d81517] RecipesPipeline v0.6.12\n [731186ca] RecursiveArrayTools v3.26.0\n [f2c3362d] RecursiveFactorization v0.2.23\n [189a3867] Reexport v1.2.2\n [05181044] RelocatableFolders v1.0.1\n [ae029012] Requires v1.3.0\n [7e49a35a] RuntimeGeneratedFunctions v0.5.13\n [94e857df] SIMDTypes v0.1.0\n [476501e8] SLEEFPirates v0.6.43\n [0aa819cd] SQLite v1.6.1\n [322a6be2] Sass v0.2.0\n [0bca4576] SciMLBase v2.42.0\n [c0aeaf25] SciMLOperators v0.3.8\n [53ae85a6] SciMLStructures v1.4.1\n [6c6a2e73] Scratch v1.2.1\n [91c51154] SentinelArrays v1.4.5\n [efcf1570] Setfield v1.1.1\n [992d4aef] Showoff v1.0.3\n [777ac1f9] SimpleBufferStream v1.1.0\n [727e6d20] SimpleNonlinearSolve v1.10.1\n [699a6c99] SimpleTraits v0.9.4\n [ce78b400] SimpleUnPack v1.1.0\n [a2af1166] SortingAlgorithms v1.2.1\n [47a9eef4] SparseDiffTools v2.19.0\n [0a514795] SparseMatrixColorings v0.3.3\n [e56a9233] Sparspak v0.3.9\n [276daf66] SpecialFunctions v2.4.0\n [aedffcd0] Static v1.1.0\n [0d7ed370] StaticArrayInterface v1.5.1\n [90137ffa] StaticArrays v1.9.7\n [1e83bf80] StaticArraysCore v1.4.3\n [82ae8749] StatsAPI v1.7.0\n [2913bbd2] StatsBase v0.34.3\n [7792a7ef] StrideArraysCore v0.5.7\n [69024149] StringEncodings v0.3.7\n [892a3eda] StringManipulation v0.3.4\n [856f2bd8] StructTypes v1.10.0\n [c3572dad] Sundials v4.24.0\n [2efcf032] SymbolicIndexingInterface v0.3.26\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.24.2\n [a759f4b9] TimerOutputs v0.5.24\n [3bb67fe8] TranscodingStreams v0.11.0\n [d5829a12] TriangularSolve v0.2.1\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.4\n [1986cc42] Unitful v1.20.0\n [45397f5d] UnitfulLatexify v1.6.4\n [41fe7b60] Unzip v0.2.0\n [3d5dd08c] VectorizationBase v0.21.70\n [19fa3120] VertexSafeGraphs v0.2.0\n [ea10d353] WeakRefStrings v1.4.2\n [76eceee3] WorkerUtilities v1.6.1\n [ddb6d928] YAML v0.4.11\n [0b7ba130] Blosc_jll v1.21.5+0\n [6e34b625] Bzip2_jll v1.0.8+1\n [83423d85] Cairo_jll v1.18.0+2\n [2702e6a9] EpollShim_jll v0.0.20230411+0\n [2e619515] Expat_jll v2.6.2+0\n⌅ [b22a6f82] FFMPEG_jll v4.4.2+2\n [a3f928ae] Fontconfig_jll v2.13.96+0\n [d7e528f0] FreeType2_jll v2.13.2+0\n [559328eb] FriBidi_jll v1.0.14+0\n [0656b61e] GLFW_jll v3.4.0+0\n⌅ [d2c73de3] GR_jll v0.73.5+0\n [78b55507] Gettext_jll v0.21.0+0\n [7746bdde] Glib_jll v2.80.2+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 v2024.2.0+0\n [aacddb02] JpegTurbo_jll v3.0.3+0\n [c1c5ebd0] LAME_jll v3.100.2+0\n⌅ [88015f11] LERC_jll v3.0.0+1\n [1d63c593] LLVMOpenMP_jll v15.0.7+0\n [dd4b983a] LZO_jll v2.10.2+0\n⌅ [e9f186c6] Libffi_jll v3.2.2+1\n [d4300ac3] Libgcrypt_jll v1.8.11+0\n [7e76a0d4] Libglvnd_jll v1.6.0+0\n [7add5ba3] Libgpg_error_jll v1.49.0+0\n [94ce4f54] Libiconv_jll v1.17.0+0\n [4b2f31a3] Libmount_jll v2.40.1+0\n⌅ [89763e89] Libtiff_jll v4.5.1+1\n [38a345b3] Libuuid_jll v2.40.1+0\n [5ced341a] Lz4_jll v1.9.4+0\n [856f044c] MKL_jll v2024.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.43.4+0\n⌅ [c0090381] Qt6Base_jll v6.5.2+2\n [76ed43ae] SQLite_jll v3.45.3+0\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.13.1+0\n [aed1982a] XSLT_jll v1.1.41+0\n [ffd25f8a] XZ_jll v5.4.6+0\n [f67eecfb] Xorg_libICE_jll v1.1.1+0\n [c834827a] Xorg_libSM_jll v1.2.4+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.6+0\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.11+0\n [14d82f49] Xorg_libpthread_stubs_jll v0.1.1+0\n [c7cfdc94] Xorg_libxcb_jll v1.17.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.6+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.9.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.43+1\n [47bcb7c8] libsass_jll v3.6.6+0\n [f27f6e37] libvorbis_jll v1.3.7+1\n [009596ad] mtdev_jll v1.1.6+0\n [1317d2d5] oneTBB_jll v2021.12.0+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.1.1+0\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+4\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"},"time_series_in_memory":false},"units_settings":{"base_value":100.0,"unit_system":"SYSTEM_BASE","__metadata__":{"module":"InfrastructureSystems","type":"SystemUnitsSettings"}},"frequency":60.0,"runchecks":true,"metadata":{"name":null,"description":null,"__metadata__":{"module":"PowerSystems","type":"SystemMetadata"}},"data_format_version":"4.0.0"} \ No newline at end of file diff --git a/previews/PR385/tutorials/tutorial_240bus/index.html b/previews/PR385/tutorials/tutorial_240bus/index.html index 9e36ac937..542446f3b 100644 --- a/previews/PR385/tutorials/tutorial_240bus/index.html +++ b/previews/PR385/tutorials/tutorial_240bus/index.html @@ -355,25 +355,25 @@ │ ─────────────────────────────────────────────────────────────────────────────── │ Time Allocations │ ─────────────── ─────────────── -│ Total measured: 26.9s 4.84GiB +│ Total measured: 27.3s 4.84GiB │ │ Section ncalls time %tot alloc %tot │ ─────────────────────────────────────────────────────────────────────────────── -│ Build Simulation 1 26.9s 100.0% 4.84GiB 100.0% -│ Build Simulation Inputs 1 2.69s 10.0% 147MiB 3.0% -│ Wrap Branches 1 11.2μs 0.0% 208B 0.0% -│ Wrap Dynamic Injectors 1 1.65s 6.1% 95.2MiB 1.9% -│ Calculate MM, DAE_vector, Tota... 1 231ms 0.9% 18.6MiB 0.4% -│ Wrap Static Injectors 1 245ms 0.9% 5.92MiB 0.1% -│ Pre-initialization 1 5.46s 20.3% 293MiB 5.9% -│ Power Flow solution 1 1.16s 4.3% 44.0MiB 0.9% -│ Initialize Static Injectors 1 1.11μs 0.0% 0.00B 0.0% -│ Initialize Dynamic Injectors 1 4.29s 16.0% 249MiB 5.0% -│ Calculate Jacobian 1 13.7s 51.1% 4.16GiB 85.9% -│ Make Model Function 1 23.8μs 0.0% 32.0KiB 0.0% -│ Initial Condition NLsolve refine... 1 4.54s 16.9% 249MiB 5.0% -│ Build Perturbations 1 119μs 0.0% 75.1KiB 0.0% -│ Make DiffEq Problem 1 456ms 1.7% 11.3MiB 0.2% +│ Build Simulation 1 27.3s 100.0% 4.84GiB 100.0% +│ Build Simulation Inputs 1 2.57s 9.4% 144MiB 2.9% +│ Wrap Branches 1 10.7μs 0.0% 208B 0.0% +│ Wrap Dynamic Injectors 1 1.63s 6.0% 95.2MiB 1.9% +│ Calculate MM, DAE_vector, Tota... 1 222ms 0.8% 18.6MiB 0.4% +│ Wrap Static Injectors 1 257ms 0.9% 8.99MiB 0.2% +│ Pre-initialization 1 5.33s 19.5% 311MiB 6.3% +│ Power Flow solution 1 1.06s 3.9% 44.0MiB 0.9% +│ Initialize Static Injectors 1 932ns 0.0% 0.00B 0.0% +│ Initialize Dynamic Injectors 1 4.26s 15.6% 267MiB 5.4% +│ Calculate Jacobian 1 14.4s 52.7% 4.15GiB 85.6% +│ Make Model Function 1 28.3μs 0.0% 32.0KiB 0.0% +│ Initial Condition NLsolve refine... 1 4.52s 16.6% 249MiB 5.0% +│ Build Perturbations 1 108μs 0.0% 75.1KiB 0.0% +│ Make DiffEq Problem 1 475ms 1.7% 11.3MiB 0.2% │ ─────────────────────────────────────────────────────────────────────────────── └ Simulation Summary @@ -396,7 +396,7 @@ │ Time Span │ (0.0, 20.0) │ │ Total Time Steps │ 2015 │ │ Number of States │ 2164 │ -│ Total solve time │ 16.760477687 │ +│ Total solve time │ 16.545760831 │ └────────────────────────────┴──────────────┘
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
@@ -425,25 +425,25 @@
 │  ───────────────────────────────────────────────────────────────────────────────
 │                                                      Time          Allocations  
 │                                                ───────────────   ───────────────
-│                 Total measured:                     8.99s             804MiB    
+│                 Total measured:                     8.96s             800MiB    
 │ 
 │  Section                               ncalls     time    %tot     alloc    %tot
 │  ───────────────────────────────────────────────────────────────────────────────
-│  Build Simulation                           1    8.99s  100.0%    804MiB  100.0%
-│    Build Simulation Inputs                  1   5.96ms    0.1%   7.33MiB    0.9%
-│      Wrap Branches                          1   5.10μs    0.0%      208B    0.0%
-│      Wrap Dynamic Injectors                 1   3.63ms    0.0%   2.47MiB    0.3%
-│      Calculate MM, DAE_vector, Tota...      1    536μs    0.0%   1.90MiB    0.2%
-│      Wrap Static Injectors                  1    466μs    0.0%    290KiB    0.0%
-│    Pre-initialization                       1   16.2ms    0.2%   9.63MiB    1.2%
-│      Power Flow solution                    1   10.9ms    0.1%   5.72MiB    0.7%
-│      Initialize Static Injectors            1    831ns    0.0%     0.00B    0.0%
-│      Initialize Dynamic Injectors           1   4.89ms    0.1%   3.76MiB    0.5%
-│    Calculate Jacobian                       1    7.23s   80.5%    600MiB   74.7%
-│    Make Model Function                      1   6.86ms    0.1%    154KiB    0.0%
-│    Initial Condition NLsolve refine...      1    1.32s   14.7%    167MiB   20.8%
-│    Build Perturbations                      1   17.7ms    0.2%    626KiB    0.1%
-│    Make DiffEq Problem                      1    388ms    4.3%   18.1MiB    2.3%
+│  Build Simulation                           1    8.96s  100.0%    800MiB  100.0%
+│    Build Simulation Inputs                  1   6.49ms    0.1%   7.33MiB    0.9%
+│      Wrap Branches                          1   5.52μs    0.0%      208B    0.0%
+│      Wrap Dynamic Injectors                 1   3.55ms    0.0%   2.47MiB    0.3%
+│      Calculate MM, DAE_vector, Tota...      1    538μs    0.0%   1.90MiB    0.2%
+│      Wrap Static Injectors                  1    435μs    0.0%    290KiB    0.0%
+│    Pre-initialization                       1   45.7ms    0.5%   9.63MiB    1.2%
+│      Power Flow solution                    1   10.8ms    0.1%   5.72MiB    0.7%
+│      Initialize Static Injectors            1    711ns    0.0%     0.00B    0.0%
+│      Initialize Dynamic Injectors           1   34.5ms    0.4%   3.76MiB    0.5%
+│    Calculate Jacobian                       1    7.25s   81.0%    597MiB   74.6%
+│    Make Model Function                      1   6.27ms    0.1%    154KiB    0.0%
+│    Initial Condition NLsolve refine...      1    1.24s   13.9%    167MiB   20.9%
+│    Build Perturbations                      1   17.6ms    0.2%    626KiB    0.1%
+│    Make DiffEq Problem                      1    387ms    4.3%   18.1MiB    2.3%
 │  ───────────────────────────────────────────────────────────────────────────────
 └ 
 Simulation Summary
@@ -473,5 +473,5 @@
 │ Time Span                  │ (0.0, 20.0)  │
 │ Total Time Steps           │ 2002         │
 │ Number of States           │ 2164         │
-│ Total solve time           │ 32.288802261 │
+│ Total solve time           │ 31.918873607 │
 └────────────────────────────┴──────────────┘

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/PR385/tutorials/tutorial_dynamic_lines/index.html b/previews/PR385/tutorials/tutorial_dynamic_lines/index.html index ce422b5ad..9b8e80dd3 100644 --- a/previews/PR385/tutorials/tutorial_dynamic_lines/index.html +++ b/previews/PR385/tutorials/tutorial_dynamic_lines/index.html @@ -170,7 +170,7 @@ │ Time Span │ (0.0, 30.0) │ │ Total Time Steps │ 1607 │ │ Number of States │ 33 │ -│ Total solve time │ 2.50966353 │ +│ Total solve time │ 2.459649192 │ └────────────────────────────┴─────────────┘
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.839541534695492, 29.85954153469549, 29.87954153469549, 29.89954153469549, 29.91954153469549, 29.93954153469549, 29.95954153469549, 29.97954153469549, 29.99954153469549, 30.0], [1.0142000000000002, 1.0142000000001268, 1.0142000000001326, 1.0142000000001927, 1.01420000000014, 1.014200000000125, 1.0142000000001052, 1.0142000000000875, 1.014200000000071, 1.0142000000000564 … 1.0140816770731862, 1.0140823112693074, 1.014082942782043, 1.0140835715610197, 1.014084197556442, 1.0140848207190936, 1.0140854410003397, 1.0140860583521298, 1.0140866727269955, 1.014086686775199])
julia> zoom = [ (series2[1][ix], series2[2][ix]) for (ix, s) in enumerate(series2[1]) if (s > 0.90 && s < 1.6) @@ -294,7 +294,7 @@ │ Time Span │ (0.0, 30.0) │ │ Total Time Steps │ 1721 │ │ Number of States │ 35 │ -│ Total solve time │ 2.456419334 │ +│ Total solve time │ 2.356870386 │ └────────────────────────────┴─────────────┘
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) diff --git a/previews/PR385/tutorials/tutorial_inverter_modeling/index.html b/previews/PR385/tutorials/tutorial_inverter_modeling/index.html index dc0c61191..d78ae85db 100644 --- a/previews/PR385/tutorials/tutorial_inverter_modeling/index.html +++ b/previews/PR385/tutorials/tutorial_inverter_modeling/index.html @@ -212,7 +212,7 @@ │ Time Span │ (0.0, 20.0) │ │ Total Time Steps │ 342 │ │ Number of States │ 86 │ -│ Total solve time │ 2.229141163 │ +│ Total solve time │ 2.164100272 │ └────────────────────────────┴─────────────┘
julia> p = plot();
julia> for b in get_components(ACBus, sys) voltage_series = get_voltage_magnitude_series(result, get_number(b)) plot!( diff --git a/previews/PR385/tutorials/tutorial_omib/index.html b/previews/PR385/tutorials/tutorial_omib/index.html index 5b689bdf4..675f946fb 100644 --- a/previews/PR385/tutorials/tutorial_omib/index.html +++ b/previews/PR385/tutorials/tutorial_omib/index.html @@ -77,7 +77,7 @@ │ Time Span │ (0.0, 30.0) │ │ Total Time Steps │ 1512 │ │ Number of States │ 6 │ -│ Total solve time │ 1.591202145 │ +│ Total solve time │ 1.558442583 │ └────────────────────────────┴─────────────┘

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

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

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          │