Introduction

The SystemStructure provides a flexible framework for defining the physical structure of airborne wind energy (AWE) systems using discrete mass-spring-damper models. This structure can represent many different AWE system configurations, from simple single-line kites to complex multi-wing systems with intricate bridle networks.

The SystemStructure serves as input to the SymbolicAWEModel, which is based on ModelingToolkit and automatically generates symbolic differential algebraic equations from the structural definition.

Workflow

  1. Define system components (Point, Segment, Group, etc.)
  2. Assemble into a SystemStructure
  3. Pass to SymbolicAWEModel for automatic MTK model generation
  4. Simulate the resulting symbolic model

Public enumerations

SymbolicAWEModels.SegmentTypeType
SegmentType `POWER_LINE` `STEERING_LINE` `BRIDLE`

Enumeration for the type of a tether segment.

Elements

  • POWER_LINE: A segment belonging to a main power line.
  • STEERING_LINE: A segment belonging to a steering line.
  • BRIDLE: A segment belonging to the bridle system.
source
SymbolicAWEModels.DynamicsTypeType
DynamicsType `DYNAMIC` `QUASI_STATIC` `WING` `STATIC`

Enumeration for the dynamic model governing a point's motion.

Elements

  • DYNAMIC: The point is a dynamic point mass, moving according to Newton's second law.
  • QUASI_STATIC: The point's acceleration is constrained to zero, representing a force equilibrium.
  • WING: The point is rigidly attached to a wing body and moves with it.
  • STATIC: The point's position is fixed in the world frame.
source

Core Model Type

This is the main struct that defines any complete simulation model.

SymbolicAWEModels.SymbolicAWEModelType
mutable struct SymbolicAWEModel <: AbstractKiteModel

The main state container for a kite power system model, built using ModelingToolkit.jl.

This struct holds the complete state of the simulation, including the physical structure (SystemStructure), the compiled model (SerializedModel), the atmospheric model, and the ODE integrator.

Users typically interact with this model through high-level functions like init! and next_step! rather than accessing its fields directly.

Type Parameters

  • S: Scalar type, typically SimFloat.
  • V: Vector type, typically KVec3.
  • P: Number of tether points in the system.
  • set::Settings: Reference to the settings struct

  • sys_struct::SystemStructure: Reference to the point mass system with points, segments, pulleys and tethers

  • serialized_model::SymbolicAWEModels.SerializedModel: Container for the compiled and serialized model components

  • am::AtmosphericModels.AtmosphericModel: Reference to the atmospheric model as implemented in the package AtmosphericModels Default: AtmosphericModel(set)

  • integrator::Union{Nothing, OrdinaryDiffEqCore.ODEIntegrator}: The ODE integrator for the full nonlinear model Default: nothing

  • t_0::Float64: Relative start time of the current time interval Default: 0.0

  • iter::Int64: Number of next_step! calls Default: 0

  • t_vsm::Float64: Time spent in the VSM linearization step Default: zero(SimFloat)

  • t_step::Float64: Time spent in the ODE integration step Default: zero(SimFloat)

  • set_tether_len::Vector{Float64}: Vector of tether length set-points Default: zeros(SimFloat, 3)

source
SymbolicAWEModels.SymbolicAWEModelMethod
SymbolicAWEModel(set::Settings, sys_struct::SystemStructure; kwargs...)

Constructs a SymbolicAWEModel from an existing SystemStructure.

This is the primary inner constructor. It takes a SystemStructure that defines the physical layout of the kite system and prepares it for symbolic model generation.

Arguments

  • set::Settings: Configuration parameters.
  • sys_struct::SystemStructure: The physical system definition.
  • kwargs...: Further keyword arguments passed to the SymbolicAWEModel constructor.

Returns

  • SymbolicAWEModel: A model ready for symbolic equation generation via init!.
source
SymbolicAWEModels.SymbolicAWEModelMethod
SymbolicAWEModel(set::Settings; kwargs...)

Constructs a default SymbolicAWEModel with automatically generated components.

This convenience constructor automatically creates a complete AWE model:

  • It first builds a SystemStructure based on the wing geometry and settings.
  • Then, it assembles everything into a ready-to-use symbolic model.

Arguments

  • set::Settings: Configuration parameters.
  • kwargs...: Further keyword arguments passed to the SystemStructure constructor.

Returns

  • SymbolicAWEModel: A model ready for symbolic equation generation via init!.
source
SymbolicAWEModels.SymbolicAWEModelMethod
SymbolicAWEModel(set::Settings, name::String; kwargs...)

Constructs a SymbolicAWEModel for a specific named physical model.

This convenience constructor sets the physical_model field of the Settings struct and then proceeds to create the model.

source

System structure and components

SymbolicAWEModels.SystemStructureType
struct SystemStructure

A discrete mass-spring-damper representation of a kite system.

This struct holds all components of the physical model, including points, segments, winches, and wings, forming a complete description of the kite system's structure.

Components

  • Point: Point masses.
  • Group: Collections of points for wing deformation.
  • Segment: Spring-damper elements.
  • Pulley: Elements that redistribute line lengths.
  • Tether: Groups of segments controlled by a winch.
  • Winch: Ground-based winches.
  • Wing: Rigid wing bodies.
  • Transform: Spatial transformations for initial positioning.
source
SymbolicAWEModels.SystemStructureMethod
SystemStructure(name, set; points, groups, segments, pulleys, tethers, winches, wings, transforms)

Constructs a SystemStructure object representing a complete kite system.

Physical Models

  • "ram": A model with 4 deformable wing groups and a complex pulley bridle system.
  • "simple_ram": A model with 4 deformable wing groups and direct bridle connections.

Arguments

  • name::String: Model identifier ("ram", "simple_ram", or a custom name).
  • set::Settings: Configuration parameters from KiteUtils.jl.

Keyword Arguments

  • points, groups, segments, etc.: Vectors of the system components.

Returns

  • SystemStructure: A complete system ready for building a SymbolicAWEModel.
source
SymbolicAWEModels.PointType
mutable struct Point

A point mass, representing a node in the mass-spring system.

  • idx::Int16

  • transform_idx::Int16

  • wing_idx::Int16

  • pos_cad::StaticArraysCore.MVector{3, Float64}

  • pos_b::StaticArraysCore.MVector{3, Float64}

  • pos_w::StaticArraysCore.MVector{3, Float64}

  • vel_w::StaticArraysCore.MVector{3, Float64}

  • disturb::StaticArraysCore.MVector{3, Float64}

  • force::StaticArraysCore.MVector{3, Float64}

  • type::DynamicsType

  • mass::Float64

  • bridle_damping::Float64

  • fix_sphere::Bool

source
SymbolicAWEModels.PointMethod
Point(idx, pos_cad, type; wing_idx=1, vel_w=zeros(KVec3), transform_idx=1, mass=0.0)

Constructs a Point object, which can be of four different DynamicsTypes:

  • STATIC: The point does not move. $\ddot{\mathbf{r}} = \mathbf{0}$
  • DYNAMIC: The point moves according to Newton's second law. $\ddot{\mathbf{r}} = \mathbf{F}/m$
  • QUASI_STATIC: The acceleration is constrained to be zero by solving a nonlinear problem. $\mathbf{F}/m = \mathbf{0}$
  • WING: The point has a static position in the rigid body wing frame. $\mathbf{r}_w = \mathbf{r}_{wing} + \mathbf{R}_{b\rightarrow w} \mathbf{r}_b$

where:

  • $\mathbf{r}$ is the point position vector
  • $\mathbf{F}$ is the net force acting on the point
  • $m$ is the point mass
  • $\mathbf{r}_w$ is the position in world frame
  • $\mathbf{r}_{wing}$ is the wing center position
  • $\mathbf{R}_{b\rightarrow w}$ is the rotation matrix from body to world frame
  • $\mathbf{r}_b$ is the position in body frame

Arguments

  • idx::Int16: Unique identifier for the point.
  • pos_cad::KVec3: Position of the point in the CAD frame.
  • type::DynamicsType: Dynamics type of the point (STATIC, DYNAMIC, etc.).

Keyword Arguments

  • wing_idx::Int16=1: Index of the wing this point is attached to.
  • vel_w::KVec3=zeros(KVec3): Initial velocity of the point in world frame.
  • transform_idx::Int16=1: Index of the transform used for initial positioning.
  • mass::Float64=0.0: Mass of the point [kg].
  • bridle_damping::Float64=0.0: Damping coefficient for bridle points.
  • fix_sphere::Bool=false: If true, constrains the point to a sphere.

Returns

  • Point: A new Point object.
source
SymbolicAWEModels.GroupType
mutable struct Group

A set of bridle lines that share the same twist angle and trailing edge angle.

  • idx::Int16

  • point_idxs::Vector{Int16}

  • le_pos::StaticArraysCore.MVector{3, Float64}

  • chord::StaticArraysCore.MVector{3, Float64}

  • y_airf::StaticArraysCore.MVector{3, Float64}

  • type::DynamicsType

  • moment_frac::Float64

  • damping::Float64

  • twist::Float64

  • twist_ω::Float64

  • tether_force::Float64

  • tether_moment::Float64

  • aero_moment::Float64

source
SymbolicAWEModels.GroupMethod
Group(idx, point_idxs, vsm_wing::RamAirWing, gamma, type, moment_frac)

Constructs a Group object representing a collection of points on a kite body that share a common twist deformation.

A Group models the local deformation of a kite wing section through twist dynamics. All points within a group undergo the same twist rotation about the chord vector.

The governing equation is:

\[\begin{aligned} \tau = \underbrace{\sum_{i=1}^{4} r_{b,i} \times (\mathbf{F}_{b,i} \cdot \hat{\mathbf{z}})}_{\text{bridles}} + \underbrace{r_a \times (\mathbf{F}_a \cdot \hat{\mathbf{z}})}_{\text{aero}} \end{aligned}\]

System Overview

where:

  • $\tau$ is the total torque about the twist axis
  • $r_{b,i}$ is the position vector of bridle point $i$ relative to the twist center
  • $\mathbf{F}_{b,i}$ is the force at bridle point $i$
  • $\hat{\mathbf{z}}$ is the unit vector along the twist axis (chord direction)
  • $r_a$ is the position vector of the aerodynamic center relative to the twist center
  • $\mathbf{F}_a$ is the aerodynamic force at the group's aerodynamic center

The group can have two DynamicsTypes:

  • DYNAMIC: the group rotates according to Newton's second law: $I\ddot{\theta} = \tau$
  • QUASI_STATIC: the rotational acceleration is zero: $\tau = 0$

Arguments

  • idx::Int16: Unique identifier for the group.
  • point_idxs::Vector{Int16}: Indices of points that move together with this group's twist.
  • vsm_wing::RamAirWing: Wing geometry object used to extract local chord and spanwise vectors.
  • gamma: Spanwise parameter (typically -1 to 1) defining the group's location along the wing.
  • type::DynamicsType: Dynamics type (DYNAMIC for time-varying twist, QUASI_STATIC for equilibrium).
  • moment_frac::SimFloat: Chordwise position (0=leading edge, 1=trailing edge) about which the group rotates.

Returns

  • Group: A new Group object with twist dynamics capability.
source
SymbolicAWEModels.SegmentType
mutable struct Segment

A segment representing a spring-damper connection from one point to another.

  • idx::Int16

  • point_idxs::Tuple{Int16, Int16}

  • axial_stiffness::Float64

  • axial_damping::Float64

  • l0::Float64

  • compression_frac::Float64

  • diameter::Float64

  • len::Float64

  • force::Float64

source
SymbolicAWEModels.SegmentMethod
Segment(idx, set, point_idxs, type; l0, compression_frac, axial_stiffness, axial_damping)

Constructs a Segment object representing an elastic spring-damper connection between two points.

The segment follows Hooke's law with damping and aerodynamic drag:

Spring-Damper Force:

\[\mathbf{F}_{spring} = \left[k(l - l_0) - c\dot{l}\right]\hat{\mathbf{u}}\]

Aerodynamic Drag:

\[\mathbf{F}_{drag} = \frac{1}{2}\rho C_d A |\mathbf{v}_a| \mathbf{v}_{a,\perp}\]

Total Force:

\[\mathbf{F}_{total} = \mathbf{F}_{spring} + \mathbf{F}_{drag}\]

where:

  • $k = \frac{E \pi d^2/4}{l}$ is the axial stiffness
  • $l$ is current length, $l_0$ is unstretched length
  • $c = \frac{\xi}{c_{spring}} k$ is damping coefficient
  • $\hat{\mathbf{u}} = \frac{\mathbf{r}_2 - \mathbf{r}_1}{l}$ is unit vector along segment
  • $\dot{l} = (\mathbf{v}_1 - \mathbf{v}_2) \cdot \hat{\mathbf{u}}$ is extension rate
  • $\mathbf{v}_{a,\perp}$ is apparent wind velocity perpendicular to segment

Arguments

  • idx::Int16: Unique identifier for the segment.
  • set::Settings: The settings object containing material properties.
  • point_idxs::Tuple{Int16, Int16}: Tuple containing the indices of the two points.
  • type::SegmentType: Type of the segment (POWER_LINE, STEERING_LINE, BRIDLE).

Keyword Arguments

  • l0::SimFloat=zero(SimFloat): Unstretched length [m]. Calculated from point positions if zero.
  • compression_frac::SimFloat=0.0: Stiffness reduction factor in compression.
  • axial_stiffness::Float64=NaN: Axial stiffness [N]. If NaN, it's calculated from settings.
  • axial_damping::Float64=NaN: Axial damping [Ns]. If NaN, it's calculated from settings.

Returns

  • Segment: A new Segment object.
source
SymbolicAWEModels.SegmentMethod
Segment(idx, point_idxs, axial_stiffness, axial_damping, diameter; l0, compression_frac)

Inner constructor for a Segment object. See Segment for details.

source
SymbolicAWEModels.PulleyType
mutable struct Pulley

A pulley described by two segments with the common point of the segments being the pulley.

  • idx::Int16

  • segment_idxs::Tuple{Int16, Int16}

  • type::DynamicsType

  • sum_len::Float64

  • len::Float64

  • vel::Float64

source
SymbolicAWEModels.PulleyMethod
Pulley(idx, segment_idxs, type)

Constructs a Pulley object that enforces length redistribution between two segments.

The pulley constraint maintains constant total length while allowing force transmission:

Constraint Equations:

\[l_1 + l_2 = l_{total} = \text{constant}\]

Force Balance:

\[F_{pulley} = F_1 - F_2\]

Dynamics:

\[m\ddot{l}_1 = F_{pulley} = F_1 - F_2\]

where:

  • $l_1, l_2$ are the lengths of connected segments
  • $F_1, F_2$ are the spring forces in the segments
  • $m = \rho_{tether} \pi (d/2)^2 l_{total}$ is the total mass of both segments
  • $\dot{l}_1 + \dot{l}_2 = 0$ (velocity constraint)

The pulley can have two DynamicsTypes:

  • DYNAMIC: the length redistribution follows Newton's second law: $m\ddot{l}_1 = F_1 - F_2$
  • QUASI_STATIC: the forces are balanced instantaneously: $F_1 = F_2$

Arguments

  • idx::Int16: Unique identifier for the pulley.
  • segment_idxs::Tuple{Int16, Int16}: Tuple containing the indices of the two segments.
  • type::DynamicsType: Dynamics type of the pulley (DYNAMIC or QUASI_STATIC).

Returns

  • Pulley: A new Pulley object.
source
SymbolicAWEModels.TetherType
mutable struct Tether

A collection of segments that are controlled together by a winch.

  • idx::Int16

  • segment_idxs::Vector{Int16}

  • winch_idx::Int16

  • stretched_len::Float64

source
SymbolicAWEModels.TetherMethod
Tether(idx, segment_idxs, winch_idx)

Constructs a Tether object representing a flexible line composed of multiple segments.

A tether enforces a shared unstretched length constraint across all its constituent segments:

Length Constraint:

\[\sum_{i \in \text{segments}} l_{0,i} = L\]

Winch Control: The unstretched tether length L is controlled by a winch.

Arguments

  • idx::Int16: Unique identifier for the tether.
  • segment_idxs::Vector{Int16}: Indices of segments that form this tether.
  • winch_idx::Int16: Index of the winch controlling this tether.

Returns

  • Tether: A new Tether object.
source
SymbolicAWEModels.WinchType
mutable struct Winch

A set of tethers (or a single tether) connected to a winch mechanism.

  • idx::Int16

  • tether_idxs::Vector{Int16}

  • tether_len::Union{Nothing, Float64}

  • tether_vel::Float64

  • tether_acc::Float64

  • set_value::Float64

  • brake::Bool

  • force::StaticArraysCore.MVector{3, Float64}

  • gear_ratio::Float64

  • drum_radius::Float64

  • f_coulomb::Float64

  • c_vf::Float64

  • inertia_total::Float64

  • friction::Float64

source
SymbolicAWEModels.WinchMethod
Winch(idx, set, tether_idxs; tether_len=0.0, tether_vel=0.0, brake=false)

Constructs a Winch object that controls tether length through torque or speed regulation.

The winch acceleration function α depends on the winch model type:

  • Torque-controlled: Direct torque input with motor dynamics.
  • Speed-controlled: Velocity regulation with internal control loops.

For detailed mathematical models of winch dynamics, motor characteristics, and control algorithms, see the WinchModels.jl documentation.

Arguments

  • idx::Int16: Unique identifier for the winch.
  • set::Settings: The main settings object, used to retrieve winch parameters.
  • tether_idxs::Vector{Int16}: Vector of indices of the tethers connected to this winch.

Keyword Arguments

  • tether_len::SimFloat=0.0: Initial tether length [m].
  • tether_vel::SimFloat=0.0: Initial tether velocity (reel-out rate) [m/s].
  • brake::Bool=false: If true, the winch brake is engaged.

Returns

  • Winch: A new Winch object.
source
SymbolicAWEModels.WinchMethod
Winch(idx, tether_idxs, gear_ratio, drum_radius, f_coulomb, c_vf, inertia_total; tether_len=0.0, tether_vel=0.0, brake=false)

Constructs a Winch object by directly providing its physical parameters.

This constructor is an alternative to creating a winch from a Settings object, allowing for more modular or programmatic creation of winch components.

Arguments

  • idx::Int16: Unique identifier for the winch.
  • tether_idxs::Vector{Int16}: Vector of indices of the tethers connected to this winch.
  • gear_ratio::SimFloat: The gear ratio of the winch.
  • drum_radius::SimFloat: The radius of the winch drum [m].
  • f_coulomb::SimFloat: Coulomb friction force [N].
  • c_vf::SimFloat: Viscous friction coefficient [Ns/m].
  • inertia_total::SimFloat: Total inertia of the motor, gearbox, and drum [kgm²].

Keyword Arguments

  • tether_len::SimFloat=0.0: Initial tether length [m].
  • tether_vel::SimFloat=0.0: Initial tether velocity (reel-out rate) [m/s].
  • brake::Bool=false: If true, the winch brake is engaged.

Returns

  • Winch: A new Winch object.
source
SymbolicAWEModels.AbstractWingType
abstract type AbstractWing

Abstract base type for all wing implementations.

Concrete subtypes must implement rigid body dynamics and provide a reference frame for attached points and groups.

source
SymbolicAWEModels.BaseWingType
mutable struct BaseWing <: AbstractWing

A rigid wing body that can have multiple groups of points attached to it.

The wing provides a rigid body reference frame for attached points and groups. Points with type == WING move rigidly with the wing body according to the wing's orientation matrix R_b_w and position pos_w.

Special Properties

The wing's orientation can be accessed as a rotation matrix or a quaternion:

R_matrix = wing.R_b_w
wing.R_b_w = R_matrix

quat = wing.Q_b_w
wing.Q_b_w = quat
  • idx::Int16

  • group_idxs::Vector{Int16}

  • transform_idx::Int16

  • R_b_c::Matrix{Float64}

  • pos_cad::StaticArraysCore.MVector{3, Float64}

  • Q_b_w::Vector{Float64}

  • ω_b::StaticArraysCore.MVector{3, Float64}

  • pos_w::StaticArraysCore.MVector{3, Float64}

  • vel_w::StaticArraysCore.MVector{3, Float64}

  • acc_w::StaticArraysCore.MVector{3, Float64}

  • wind_disturb::StaticArraysCore.MVector{3, Float64}

  • drag_frac::Float64

  • va_b::StaticArraysCore.MVector{3, Float64}

  • v_wind::StaticArraysCore.MVector{3, Float64}

  • aero_force_b::StaticArraysCore.MVector{3, Float64}

  • aero_moment_b::StaticArraysCore.MVector{3, Float64}

  • tether_moment::StaticArraysCore.MVector{3, Float64}

  • tether_force::StaticArraysCore.MVector{3, Float64}

  • elevation::Float64

  • elevation_vel::Float64

  • elevation_acc::Float64

  • azimuth::Float64

  • azimuth_vel::Float64

  • azimuth_acc::Float64

  • heading::Float64

  • turn_rate::StaticArraysCore.MVector{3, Float64}

  • turn_acc::StaticArraysCore.MVector{3, Float64}

  • course::Float64

  • aoa::Float64

  • fix_sphere::Bool

  • y_damping::Float64

  • z_disturb::Float64

source
SymbolicAWEModels.VSMWingType
mutable struct VSMWing <: AbstractWing

A wing that uses the Vortex Step Method (VSM) for aerodynamic computations.

This struct extends the base wing functionality with VSM-specific aerodynamic modeling capabilities, including vortex wake computations and aerodynamic loads.

  • base::SymbolicAWEModels.BaseWing

  • vsm_aero::BodyAerodynamics

  • vsm_wing::RamAirWing

  • vsm_solver::Solver

  • vsm_y::Vector{Float64}

  • vsm_x::Vector{Float64}

  • vsm_jac::Matrix{Float64}

source
VortexStepMethod.WingType
Wing(idx, vsm_aero, vsm_wing, vsm_solver, group_idxs, R_b_c, pos_cad; transform_idx)

Constructs a VSMWing object (backward compatibility constructor).

This is a convenience constructor that creates a VSMWing for backward compatibility with existing code. New code should use VSMWing(...) directly.

Arguments

  • idx::Int16: Unique identifier for the wing.
  • vsm_aero, vsm_wing, vsm_solver: Vortex Step Method components.
  • group_idxs::Vector{Int16}: Indices of groups attached to this wing.
  • R_b_c::Matrix{SimFloat}: Rotation matrix from body frame to CAD frame.
  • pos_cad::KVec3: Position of wing center of mass in CAD frame.

Keyword Arguments

  • transform_idx::Int16=1: Transform used for initial positioning and orientation.
  • y_damping::SimFloat=150.0: Damping coefficient for lateral motion.

Returns

  • VSMWing: A new VSM wing object.
source
VortexStepMethod.WingMethod
Wing(idx, vsm_aero, vsm_wing, vsm_solver, group_idxs, R_b_c, pos_cad; transform_idx)

Constructs a VSMWing object (backward compatibility constructor).

This is a convenience constructor that creates a VSMWing for backward compatibility with existing code. New code should use VSMWing(...) directly.

Arguments

  • idx::Int16: Unique identifier for the wing.
  • vsm_aero, vsm_wing, vsm_solver: Vortex Step Method components.
  • group_idxs::Vector{Int16}: Indices of groups attached to this wing.
  • R_b_c::Matrix{SimFloat}: Rotation matrix from body frame to CAD frame.
  • pos_cad::KVec3: Position of wing center of mass in CAD frame.

Keyword Arguments

  • transform_idx::Int16=1: Transform used for initial positioning and orientation.
  • y_damping::SimFloat=150.0: Damping coefficient for lateral motion.

Returns

  • VSMWing: A new VSM wing object.
source
SymbolicAWEModels.TransformType
mutable struct Transform

Describes the spatial transformation (position and orientation) of system components relative to a base reference point.

  • idx::Int16

  • wing_idx::Union{Nothing, Int16}

  • rot_point_idx::Union{Nothing, Int16}

  • base_point_idx::Union{Nothing, Int16}

  • base_transform_idx::Union{Nothing, Int16}

  • elevation::Float64

  • azimuth::Float64

  • heading::Float64

  • base_pos::Union{Nothing, StaticArraysCore.MVector{3, Float64}}

source
SymbolicAWEModels.TransformMethod
Transform(idx, elevation, azimuth, heading; base_point_idx, base_pos, base_transform_idx, wing_idx, rot_point_idx)

Constructs a Transform object that orients system components using spherical coordinates.

All points and wings with a matching transform_idx are transformed together as a rigid body:

  1. Translation: Translate such that base_point_idx is at the specified base_pos.
  2. Rotation 1: Rotate so the target (wing_idx or rot_point_idx) is at (elevation, azimuth) relative to the base.
  3. Rotation 2: Rotate all components by heading around the base-target vector.

\[\mathbf{r}_{transformed} = \mathbf{r}_{base} + \mathbf{R}_{heading} \circ \mathbf{R}_{elevation,azimuth}(\mathbf{r} - \mathbf{r}_{base})\]

Arguments

  • idx::Int16: Unique identifier for the transform.
  • elevation::SimFloat: Target elevation angle from base [rad].
  • azimuth::SimFloat: Target azimuth angle from base [rad].
  • heading::SimFloat: Rotation around base-target vector [rad].

Keyword Arguments

Base Reference (choose one method):

  • base_pos & base_point_idx: Use a fixed position and a reference point.
  • base_transform_idx: Chain to another transform's position.

Target Object (choose one):

  • wing_idx: The wing to position at (elevation, azimuth).
  • rot_point_idx: The point to position at (elevation, azimuth).

Returns

  • Transform: A transform affecting all components with a matching transform_idx.
source

System state

KiteUtils.SysStateType
SysState(s::SymbolicAWEModel, zoom=1.0)

Constructs a SysState object from a SymbolicAWEModel.

This is a convenience constructor that creates a new SysState object and populates it with the current state of the provided model.

Arguments

  • s::SymbolicAWEModel: The source model.
  • zoom::SimFloat=1.0: A scaling factor for the position coordinates.

Returns

  • SysState: A new state struct representing the current model state.
source
SysState(y::AbstractVector, sam::SymbolicAWEModel, t::Real; zoom=1.0)

Construct a SysState for logging linear state-space simulation output y (ordered as sam.outputs).

source
KiteUtils.update_sys_state!Function
update_sys_state!(ss::SysState, s::SymbolicAWEModel, zoom=1.0)

Updates a SysState object with the current state values from the SymbolicAWEModel.

This function takes the raw data from the model's internal integrator and populates the fields of the user-friendly SysState struct, converting units (e.g., radians to degrees) and calculating derived values like AoA and roll/pitch/yaw angles.

Arguments

  • ss::SysState: The state struct to be updated.
  • s::SymbolicAWEModel: The source model.
  • zoom::SimFloat=1.0: A scaling factor for the position coordinates.
source
update_sys_state!(ss::SysState, y::AbstractVector, sam::SymbolicAWEModel, t::Real;
                  zoom=1.0)

Update a SysState for a linear state-space simulation, using output y and model sam.

source
SymbolicAWEModels.update_from_sysstate!Function
update_from_sysstate!(sys::SystemStructure, ss::SysState)

Update the dynamic state of a SystemStructure from a SysState snapshot.

This function copies the state variables that are present in SysState (such as point positions, wing orientations, winch lengths, and twist angles) into an existing SystemStructure. Fields that cannot be populated from SysState (such as aerodynamic forces, moments, and segment forces) are set to NaN to prevent them from being plotted.

This is useful for visualizing a SysLog by extracting individual SysState snapshots and applying them to a SystemStructure for plotting with the Makie extension.

Arguments

  • sys::SystemStructure: The system structure to update (must already exist with correct topology).
  • ss::SysState: The state snapshot to copy from.

Example

# Load a system log
lg = load_log(...)

# Create a SystemStructure with the same topology
sys = SystemStructure(se(), "ram")

# Update from a specific time step
update_from_sysstate!(sys, lg.syslog[100])

# Plot the system at that time step
plot(sys)

Notes

  • The SystemStructure must have been created with the same model configuration as the simulation that generated the SysLog.
  • Aerodynamic and force fields are set to NaN and will not be plotted.
  • The number of points in sys must match the parametric type P of SysState{P}.
source