50#include "models/FGMassBalance.h"
51#include "models/FGPropulsion.h"
52#include "input_output/FGXMLElement.h"
53#include "input_output/string_utilities.h"
59using std::ostringstream;
67static inline double sqr(
double x) {
return x*x; }
78 Radius(0.0), BladeNum(0),
79 Sense(1.0), NominalRPM(0.0), MinimalRPM(0.0), MaximalRPM(0.0),
80 ExternalRPM(0), RPMdefinition(0), ExtRPMsource(NULL), SourceGearRatio(1.0),
81 BladeChord(0.0), LiftCurveSlope(0.0), BladeTwist(0.0), HingeOffset(0.0),
82 BladeFlappingMoment(0.0), BladeMassMoment(0.0), PolarMoment(0.0),
83 InflowLag(0.0), TipLossB(0.0),
84 GroundEffectExp(0.0), GroundEffectShift(0.0), GroundEffectScaleNorm(1.0),
85 LockNumberByRho(0.0), Solidity(0.0),
88 a0(0.0), a_1(0.0), b_1(0.0), a_dw(0.0),
90 H_drag(0.0), J_side(0.0), Torque(0.0), C_T(0.0),
91 lambda(-0.001), mu(0.0), nu(0.001), v_induced(0.0),
92 theta_downwash(0.0), phi_downwash(0.0),
93 ControlMap(eMainCtrl),
94 CollectiveCtrl(0.0), LateralCtrl(0.0), LongitudinalCtrl(0.0),
96 EngineRPM(0.0), MaxBrakePower(0.0), GearLoss(0.0), GearMoment(0.0)
100 double engine_power_est = 0.0;
103 SetTransformType(FGForce::tCustom);
108 for (
int i=0; i<5; i++) R[i] = 0.0;
109 for (
int i=0; i<5; i++) B[i] = 0.0;
113 if (thruster_element) {
117 }
else if (s < 0.1) {
125 if (thruster_element) {
128 cerr <<
"No thruster location found." << endl;
132 if (thruster_element) {
135 cerr <<
"No thruster orientation found." << endl;
138 SetLocation(location);
139 SetAnglesToBody(orientation);
143 ControlMap = eMainCtrl;
148 ControlMap = eTailCtrl;
149 }
else if (cm ==
"TANDEM") {
150 ControlMap = eTandemCtrl;
152 cerr <<
"# found unknown controlmap: '" << cm <<
"' using main rotor config." << endl;
159 SourceGearRatio = 1.0;
161 int rdef = RPMdefinition;
162 if (RPMdefinition>=0) {
164 if (!exec->
GetPropulsion()->GetEngine(RPMdefinition) || RPMdefinition==num) {
168 SourceGearRatio = tr->GetGearRatio();
172 if (RPMdefinition != rdef) {
173 cerr <<
"# discarded given RPM source (" << rdef <<
") and switched to external control (-1)." << endl;
178 engine_power_est = Configure(rotor_element);
185 Transmission->SetThrusterMoment(PolarMoment);
188 GearMoment = ConfigValueConv(rotor_element,
"gearmoment", 0.1*PolarMoment,
"SLUG*FT2");
189 GearMoment =
Constrain(1e-6, GearMoment, 1e9);
190 Transmission->SetEngineMoment(GearMoment);
192 Transmission->SetMaxBrakePower(MaxBrakePower);
194 GearLoss = ConfigValueConv(rotor_element,
"gearloss", 0.0025 * engine_power_est,
"HP");
195 GearLoss =
Constrain(0.0, GearLoss, 1e9);
196 GearLoss *= hptoftlbssec;
197 Transmission->SetEngineFriction(GearLoss);
203 TboToHsr = { 0.0, 0.0, 1.0,
210 damp_hagl =
Filter(1.0, dt);
222 if (Transmission)
delete Transmission;
230double FGRotor::ConfigValueConv(
Element* el,
const string& ename,
double default_val,
231 const string& unit,
bool tell)
235 double val = default_val;
237 string pname =
"*No parent element*";
252 cerr << pname <<
": missing element '" << ename <<
253 "' using estimated value: " << default_val << endl;
262double FGRotor::ConfigValue(Element* el,
const string& ename,
double default_val,
bool tell)
264 return ConfigValueConv(el, ename, default_val,
"", tell);
271double FGRotor::Configure(Element* rotor_element)
274 double estimate, engine_power_est=0.0;
275 const bool yell =
true;
276 const bool silent =
false;
279 Radius = 0.5 * ConfigValueConv(rotor_element,
"diameter", 42.0,
"FT", yell);
282 BladeNum = (int) ConfigValue(rotor_element,
"numblades", 3 , yell);
284 GearRatio = ConfigValue(rotor_element,
"gearratio", 1.0, yell);
285 GearRatio =
Constrain(1e-9, GearRatio, 1e9);
288 estimate = (750.0/Radius)/(2.0*M_PI) * 60.0;
289 NominalRPM = ConfigValue(rotor_element,
"nominalrpm", estimate, yell);
290 NominalRPM =
Constrain(2.0, NominalRPM, 1e9);
292 MinimalRPM = ConfigValue(rotor_element,
"minrpm", 1.0);
293 MinimalRPM =
Constrain(1.0, MinimalRPM, NominalRPM - 1.0);
295 MaximalRPM = ConfigValue(rotor_element,
"maxrpm", 2.0*NominalRPM);
296 MaximalRPM =
Constrain(NominalRPM, MaximalRPM, 1e9);
298 estimate =
Constrain(0.07, 2.0/Radius , 0.14);
299 estimate = estimate * M_PI*Radius/BladeNum;
300 BladeChord = ConfigValueConv(rotor_element,
"chord", estimate,
"FT", yell);
302 LiftCurveSlope = ConfigValue(rotor_element,
"liftcurveslope", 6.0);
303 BladeTwist = ConfigValueConv(rotor_element,
"twist", -0.17,
"RAD");
305 HingeOffset = ConfigValueConv(rotor_element,
"hingeoffset", 0.05 * Radius,
"FT" );
307 estimate = sqr(BladeChord) * sqr(Radius - HingeOffset) * 0.57;
308 BladeFlappingMoment = ConfigValueConv(rotor_element,
"flappingmoment", estimate,
"SLUG*FT2");
309 BladeFlappingMoment =
Constrain(1e-9, BladeFlappingMoment, 1e9);
312 estimate = ( 3.0 * BladeFlappingMoment / sqr(Radius) ) * (0.45 * Radius) ;
313 BladeMassMoment = ConfigValue(rotor_element,
"massmoment", estimate);
314 BladeMassMoment =
Constrain(1e-9, BladeMassMoment, 1e9);
316 estimate = 1.1 * BladeFlappingMoment * BladeNum;
317 PolarMoment = ConfigValueConv(rotor_element,
"polarmoment", estimate,
"SLUG*FT2");
318 PolarMoment =
Constrain(1e-9, PolarMoment, 1e9);
322 TipLossB = ConfigValue(rotor_element,
"tiplossfactor", 1.0, silent);
325 engine_power_est = 0.5 * BladeNum*BladeChord*Radius*Radius;
327 estimate = engine_power_est / 30.0;
328 MaxBrakePower = ConfigValueConv(rotor_element,
"maxbrakepower", estimate,
"HP");
329 MaxBrakePower *= hptoftlbssec;
331 GroundEffectExp = ConfigValue(rotor_element,
"groundeffectexp", 0.0);
332 GroundEffectShift = ConfigValueConv(rotor_element,
"groundeffectshift", 0.0,
"FT");
335 R[0]=1.0; R[1]=Radius; R[2]=R[1]*R[1]; R[3]=R[2]*R[1]; R[4]=R[3]*R[1];
336 B[0]=1.0; B[1]=TipLossB; B[2]=B[1]*B[1]; B[3]=B[2]*B[1]; B[4]=B[3]*B[1];
339 LockNumberByRho = LiftCurveSlope * BladeChord * R[4] / BladeFlappingMoment;
340 Solidity = BladeNum * BladeChord / (M_PI * Radius);
343 double omega_tmp = (NominalRPM/60.0)*2.0*M_PI;
344 estimate = 16.0/(LockNumberByRho*rho * omega_tmp );
346 InflowLag = ConfigValue(rotor_element,
"inflowlag", estimate, yell);
347 InflowLag =
Constrain(1e-6, InflowLag, 2.0);
349 return engine_power_est;
357FGColumnVector3 FGRotor::hub_vel_body2ca(
const FGColumnVector3 &uvw,
358 const FGColumnVector3 &pqr,
359 double a_ic,
double b_ic)
361 FGColumnVector3 v_r, v_shaft, v_w;
364 pos = fdmex->
GetMassBalance()->StructuralToBody(GetActingLocation());
367 v_shaft = TboToHsr * InvTransform * v_r;
369 beta_orient = atan2(v_shaft(eV),v_shaft(eU));
371 v_w(eU) = v_shaft(eU)*cos(beta_orient) + v_shaft(eV)*sin(beta_orient);
373 v_w(eW) = v_shaft(eW) - b_ic*v_shaft(eU) - a_ic*v_shaft(eV);
382FGColumnVector3 FGRotor::fus_angvel_body2ca(
const FGColumnVector3 &pqr)
384 FGColumnVector3 av_s_fus, av_w_fus;
389 av_s_fus = TboToHsr * InvTransform * pqr;
391 av_w_fus(eP)= av_s_fus(eP)*cos(beta_orient) + av_s_fus(eQ)*sin(beta_orient);
392 av_w_fus(eQ)= - av_s_fus(eP)*sin(beta_orient) + av_s_fus(eQ)*cos(beta_orient);
393 av_w_fus(eR)= av_s_fus(eR);
408void FGRotor::calc_flow_and_thrust(
double theta_0,
double Uw,
double Ww,
412 double ct_over_sigma = 0.0;
413 double c0, ct_l, ct_t0, ct_t1;
416 mu = Uw/(Omega*Radius);
417 if (mu > 0.7) mu = 0.7;
420 ct_t0 = (1.0/3.0*B[3] + 1.0/2.0 * TipLossB*mu2 - 4.0/(9.0*M_PI) * mu*mu2 ) * theta_0;
421 ct_t1 = (1.0/4.0*B[4] + 1.0/4.0 * B[2]*mu2) * BladeTwist;
423 ct_l = (1.0/2.0*B[2] + 1.0/4.0 * mu2) * lambda;
425 c0 = (LiftCurveSlope/2.0)*(ct_l + ct_t0 + ct_t1) * Solidity;
426 c0 = c0 / ( 2.0 * sqrt( sqr(mu) + sqr(lambda) ) + 1e-15);
432 nu = flow_scale * ((nu - c0) * exp(-dt/InflowLag) + c0);
436 lambda = Ww/(Omega*Radius) - nu;
438 ct_l = (1.0/2.0*B[2] + 1.0/4.0 * mu2) * lambda;
440 ct_over_sigma = (LiftCurveSlope/2.0)*(ct_l + ct_t0 + ct_t1);
442 Thrust = BladeNum*BladeChord*Radius*rho*sqr(Omega*Radius) * ct_over_sigma;
444 C_T = ct_over_sigma * Solidity;
445 v_induced = nu * (Omega*Radius);
455void FGRotor::calc_coning_angle(
double theta_0)
457 double lock_gamma = LockNumberByRho * rho;
459 double a0_l = (1.0/6.0 + 0.04 * mu*mu*mu) * lambda;
460 double a0_t0 = (1.0/8.0 + 1.0/8.0 * mu*mu) * theta_0;
461 double a0_t1 = (1.0/10.0 + 1.0/12.0 * mu*mu) * BladeTwist;
462 a0 = lock_gamma * ( a0_l + a0_t0 + a0_t1);
470void FGRotor::calc_flapping_angles(
double theta_0,
const FGColumnVector3 &pqr_fus_w)
472 double lock_gamma = LockNumberByRho * rho;
475 double mu2_2 = sqr(mu)/2.0;
476 double t075 = theta_0 + 0.75 * BladeTwist;
478 a_1 = 1.0/(1.0 - mu2_2) * (
479 (2.0*lambda + (8.0/3.0)*t075)*mu
480 + pqr_fus_w(eP)/Omega
481 - 16.0 * pqr_fus_w(eQ)/(lock_gamma*Omega)
484 b_1 = 1.0/(1.0 + mu2_2) * (
486 - pqr_fus_w(eQ)/Omega
487 - 16.0 * pqr_fus_w(eP)/(lock_gamma*Omega)
491 a_dw = 1.0/(1.0 - mu2_2) * (
492 (2.0*lambda + (8.0/3.0)*t075)*mu
493 - 24.0 * pqr_fus_w(eQ)/(lock_gamma*Omega)
494 * ( 1.0 - ( 0.29 * t075 / (C_T/Solidity) ) )
504void FGRotor::calc_drag_and_side_forces(
double theta_0)
506 double cy_over_sigma;
507 double t075 = theta_0 + 0.75 * BladeTwist;
509 H_drag = Thrust * a_dw;
512 0.75*b_1*lambda - 1.5*a0*mu*lambda + 0.25*a_1*b_1*mu
513 - a0*a_1*sqr(mu) + (1.0/6.0)*a0*a_1
514 - (0.75*mu*a0 - (1.0/3.0)*b_1 - 0.5*sqr(mu)*b_1)*t075
516 cy_over_sigma *= LiftCurveSlope/2.0;
518 J_side = BladeNum * BladeChord * Radius * rho * sqr(Omega*Radius) * cy_over_sigma;
529void FGRotor::calc_torque(
double theta_0)
532 double delta_dr = 0.009 + 0.3*sqr(6.0*C_T/(LiftCurveSlope*Solidity));
534 Torque = rho * BladeNum * BladeChord * delta_dr * sqr(Omega*Radius) * R[2] *
535 (1.0+4.5*sqr(mu))/8.0
536 - (Thrust*lambda + H_drag*mu)*Radius;
549void FGRotor::calc_downwash_angles()
551 FGColumnVector3 v_shaft;
552 v_shaft = TboToHsr * InvTransform * in.AeroUVW;
554 theta_downwash = atan2( -v_shaft(eU), v_induced - v_shaft(eW)) + a1s;
555 phi_downwash = atan2( v_shaft(eV), v_induced - v_shaft(eW)) + b1s;
565FGColumnVector3 FGRotor::body_forces(
double a_ic,
double b_ic)
568 - H_drag*cos(beta_orient) - J_side*sin(beta_orient) + Thrust*b_ic,
569 - H_drag*sin(beta_orient) + J_side*cos(beta_orient) + Thrust*a_ic,
572 return HsrToTbo * F_s;
580FGColumnVector3 FGRotor::body_moments(
double a_ic,
double b_ic)
582 FGColumnVector3 M_s, M_hub, M_h;
586 a1s = a_1*cos(beta_orient) + b_1*sin(beta_orient) - b_ic;
587 b1s = b_1*cos(beta_orient) - a_1*sin(beta_orient) + a_ic;
589 mf = 0.5 * HingeOffset * BladeNum * Omega*Omega * BladeMassMoment;
593 M_s(eN) = Torque * Sense ;
595 return HsrToTbo * M_s;
600void FGRotor::CalcRotorState(
void)
606 FGColumnVector3 vHub_ca, avFus_ca;
608 double filtered_hagl = 0.0;
609 double ge_factor = 1.0;
613 double h_agl_ft = in.H_agl;
619 if (ExternalRPM && ExtRPMsource) {
620 RPM = ExtRPMsource->getDoubleValue() * ( SourceGearRatio / GearRatio );
624 RPM =
Constrain(MinimalRPM, RPM, MaximalRPM);
626 Omega = (RPM/60.0)*2.0*M_PI;
630 B_IC = LongitudinalCtrl;
631 theta_col = CollectiveCtrl;
635 if (GroundEffectExp > 1e-5) {
636 if (h_agl_ft<0.0) h_agl_ft = 0.0;
637 filtered_hagl = damp_hagl.execute(h_agl_ft) + GroundEffectShift;
639 ge_factor -= GroundEffectScaleNorm *
640 ( exp(-filtered_hagl*GroundEffectExp) * (RPM / NominalRPM) );
641 ge_factor =
Constrain(0.5, ge_factor, 1.0);
646 vHub_ca = hub_vel_body2ca(in.AeroUVW, in.AeroPQR, A_IC, B_IC);
648 avFus_ca = fus_angvel_body2ca(in.AeroPQR);
650 calc_flow_and_thrust(theta_col, vHub_ca(eU), vHub_ca(eW), ge_factor);
652 calc_coning_angle(theta_col);
654 calc_flapping_angles(theta_col, avFus_ca);
656 calc_drag_and_side_forces(theta_col);
658 calc_torque(theta_col);
660 calc_downwash_angles();
664 vFn = body_forces(A_IC, B_IC);
665 vMn = Transform() * body_moments(A_IC, B_IC);
678 Transmission->Calculate(EnginePower, Torque, in.TotalDeltaT);
680 EngineRPM = Transmission->GetEngineRPM() * GearRatio;
681 RPM = Transmission->GetThrusterRPM();
683 EngineRPM = RPM * GearRatio;
686 RPM =
Constrain(MinimalRPM, RPM, MaximalRPM);
697 string property_name, base_property_name;
698 base_property_name = CreateIndexedPropertyName(
"propulsion/engine", EngineNum);
700 property_name = base_property_name +
"/rotor-rpm";
703 property_name = base_property_name +
"/engine-rpm";
706 property_name = base_property_name +
"/a0-rad";
709 property_name = base_property_name +
"/a1-rad";
712 property_name = base_property_name +
"/b1-rad";
715 property_name = base_property_name +
"/inflow-ratio";
718 property_name = base_property_name +
"/advance-ratio";
721 property_name = base_property_name +
"/induced-inflow-ratio";
724 property_name = base_property_name +
"/vi-fps";
727 property_name = base_property_name +
"/thrust-coefficient";
730 property_name = base_property_name +
"/torque-lbsft";
733 property_name = base_property_name +
"/theta-downwash-rad";
736 property_name = base_property_name +
"/phi-downwash-rad";
739 property_name = base_property_name +
"/groundeffect-scale-norm";
743 switch (ControlMap) {
745 property_name = base_property_name +
"/antitorque-ctrl-rad";
749 property_name = base_property_name +
"/tail-collective-ctrl-rad";
751 property_name = base_property_name +
"/lateral-ctrl-rad";
753 property_name = base_property_name +
"/longitudinal-ctrl-rad";
757 property_name = base_property_name +
"/collective-ctrl-rad";
759 property_name = base_property_name +
"/lateral-ctrl-rad";
761 property_name = base_property_name +
"/longitudinal-ctrl-rad";
766 if (RPMdefinition == -1) {
767 property_name = base_property_name +
"/x-rpm-dict";
768 ExtRPMsource = PropertyManager->GetNode(property_name,
true);
769 }
else if (RPMdefinition >= 0 && RPMdefinition != EngineNum) {
770 string ipn = CreateIndexedPropertyName(
"propulsion/engine", RPMdefinition);
771 property_name = ipn +
"/rotor-rpm";
772 ExtRPMsource = PropertyManager->GetNode(property_name,
false);
773 if (! ExtRPMsource) {
774 cerr <<
"# Warning: Engine number " << EngineNum <<
"." << endl;
775 cerr <<
"# No 'rotor-rpm' property found for engine " << RPMdefinition <<
"." << endl;
776 cerr <<
"# Please check order of engine definitons." << endl;
779 cerr <<
"# Engine number " << EngineNum;
780 cerr <<
", given ExternalRPM value '" << RPMdefinition <<
"' unhandled." << endl;
789string FGRotor::GetThrusterLabels(
int id,
const string& delimeter)
794 buf << Name <<
" RPM (engine " <<
id <<
")";
802string FGRotor::GetThrusterValues(
int id,
const string& delimeter)
832void FGRotor::Debug(
int from)
834 string ControlMapName;
836 if (debug_lvl <= 0)
return;
840 cout <<
"\n Rotor Name: " << Name << endl;
841 cout <<
" Diameter = " << 2.0 * Radius <<
" ft." << endl;
842 cout <<
" Number of Blades = " << BladeNum << endl;
843 cout <<
" Gear Ratio = " << GearRatio << endl;
844 cout <<
" Sense = " << Sense << endl;
845 cout <<
" Nominal RPM = " << NominalRPM << endl;
846 cout <<
" Minimal RPM = " << MinimalRPM << endl;
847 cout <<
" Maximal RPM = " << MaximalRPM << endl;
850 if (RPMdefinition == -1) {
851 cout <<
" RPM is controlled externally" << endl;
853 cout <<
" RPM source set to thruster " << RPMdefinition << endl;
857 cout <<
" Blade Chord = " << BladeChord << endl;
858 cout <<
" Lift Curve Slope = " << LiftCurveSlope << endl;
859 cout <<
" Blade Twist = " << BladeTwist << endl;
860 cout <<
" Hinge Offset = " << HingeOffset << endl;
861 cout <<
" Blade Flapping Moment = " << BladeFlappingMoment << endl;
862 cout <<
" Blade Mass Moment = " << BladeMassMoment << endl;
863 cout <<
" Polar Moment = " << PolarMoment << endl;
864 cout <<
" Inflow Lag = " << InflowLag << endl;
865 cout <<
" Tip Loss = " << TipLossB << endl;
866 cout <<
" Lock Number = " << LockNumberByRho * 0.002356 <<
" (SL)" << endl;
867 cout <<
" Solidity = " << Solidity << endl;
868 cout <<
" Max Brake Power = " << MaxBrakePower/hptoftlbssec <<
" HP" << endl;
869 cout <<
" Gear Loss = " << GearLoss/hptoftlbssec <<
" HP" << endl;
870 cout <<
" Gear Moment = " << GearMoment << endl;
872 switch (ControlMap) {
873 case eTailCtrl: ControlMapName =
"Tail Rotor";
break;
874 case eTandemCtrl: ControlMapName =
"Tandem Rotor";
break;
875 default: ControlMapName =
"Main Rotor";
877 cout <<
" Control Mapping = " << ControlMapName << endl;
881 if (debug_lvl & 2 ) {
882 if (from == 0) cout <<
"Instantiated: FGRotor" << endl;
883 if (from == 1) cout <<
"Destroyed: FGRotor" << endl;
885 if (debug_lvl & 4 ) {
887 if (debug_lvl & 8 ) {
889 if (debug_lvl & 16) {
891 if (debug_lvl & 64) {
Element * FindElement(const std::string &el="")
Searches for a specified element.
const std::string & GetName(void) const
Retrieves the element name.
FGColumnVector3 FindElementTripletConvertTo(const std::string &target_units)
Composes a 3-element column vector for the supplied location or orientation.
Element * GetParent(void)
Returns a pointer to the parent of an element.
std::string FindElementValue(const std::string &el="")
Searches for the named element and returns the string data belonging to it.
double FindElementValueAsNumberConvertTo(const std::string &el, const std::string &target_units)
Searches for the named element and converts and returns the data belonging to it.
double GetDataAsNumber(void)
Converts the element data to a number.
double FindElementValueAsNumber(const std::string &el="")
Searches for the named element and returns the data belonging to it as a number.
This class implements a 3 element column vector.
Encapsulates the JSBSim simulation executive.
double GetDeltaT(void) const
Returns the simulation delta T.
std::shared_ptr< FGMassBalance > GetMassBalance(void) const
Returns the FGAircraft pointer.
std::shared_ptr< FGPropulsion > GetPropulsion(void) const
Returns the FGPropulsion pointer.
std::shared_ptr< FGPropertyManager > GetPropertyManager(void) const
Returns a pointer to the property manager object.
First order, (low pass / lag) filter.
static constexpr double Constrain(double min, double value, double max)
Constrain a value between a minimum and a maximum value.
FGMatrix33 Transposed(void) const
Transposed matrix.
void Tie(const std::string &name, T *pointer)
Tie a property to an external variable.
double GetLambda(void) const
Retrieves the inflow ratio.
double Calculate(double EnginePower)
Returns the scalar thrust of the rotor, and adjusts the RPM value.
double GetB1(void) const
Retrieves the lateral flapping angle with respect to the rotor shaft.
double GetGroundEffectScaleNorm(void) const
Retrieves the ground effect scaling factor.
double GetRPM(void) const
Retrieves the RPMs of the rotor.
FGRotor(FGFDMExec *exec, Element *rotor_element, int num)
Constructor for FGRotor.
~FGRotor()
Destructor for FGRotor.
void SetCollectiveCtrl(double c)
Sets the collective control input in radians.
double GetCollectiveCtrl(void) const
Retrieves the collective control input in radians.
void SetGroundEffectScaleNorm(double g)
Sets the ground effect scaling factor.
double GetLongitudinalCtrl(void) const
Retrieves the longitudinal control input in radians.
void SetLongitudinalCtrl(double c)
Sets the longitudinal control input in radians.
double GetTorque(void) const
Retrieves the torque.
void SetLateralCtrl(double c)
Sets the lateral control input in radians.
double GetMu(void) const
Retrieves the tip-speed (aka advance) ratio.
double GetPhiDW(void) const
Downwash angle - positive values point leftward (given a horizontal spinning rotor)
double GetCT(void) const
Retrieves the thrust coefficient.
double GetEngineRPM(void) const
Retrieves the RPMs of the Engine, as seen from this rotor.
double GetA1(void) const
Retrieves the longitudinal flapping angle with respect to the rotor shaft.
double GetNu(void) const
Retrieves the induced inflow ratio.
double GetThetaDW(void) const
Downwash angle - positive values point forward (given a horizontal spinning rotor)
double GetA0(void) const
Retrieves the rotor's coning angle.
double GetVi(void) const
Retrieves the induced velocity.
double GetLateralCtrl(void) const
Retrieves the lateral control input in radians.
Base class for specific thrusting devices such as propellers, nozzles, etc.
Utility class that handles power transmission in conjunction with FGRotor.