Main Page | Modules | Namespace List | Class Hierarchy | Alphabetical List | Class List | Directories | File List | Namespace Members | Class Members | File Members | Related Pages | Examples

Matrix.h File Reference


Detailed Description

Wrapper of CammVa Matrix & Matrix Library.

Author:
Andrew Turner <ajturner@vt.edu>
Version:
0.1
Date:
2003 ////////////////////////////////////////////////////////////////////////////////////////////////
Todo:
Add overloading of operators

Reference cammva documentation

Definition in file Matrix.h.

#include <iostream>
#include "cammva.h"
#include <math.h>

Include dependency graph for Matrix.h:

Include dependency graph

This graph shows which files directly or indirectly include this file:

Included by dependency graph

Go to the source code of this file.

Namespaces

namespace  O_SESSAME

Typedefs

typedef CAMdoubleMatrix Matrix
typedef CAMdoubleVector Vector

Functions

Vector Vabs (Vector _vector)
 Returns the absolute value of a vector.
Matrix eye (int _rowColumns)
 Creates an square identity matrix of specified size.
double trace (const Matrix &_inMatrix)
 Calculates the trace of matrix (sum of elements along diagonal).
double norm2 (const Vector &_inVector)
 Calculates the 2-norm of the vector (square-root of the sum of the squares).
void normalize (Vector &_inVector)
 Normalizes a vector.
double normInf (const Vector &_inVector)
 Calculates the Infinity-norm of the vector (largest value of the components).
Matrix skew (const Vector &_inVector)
 Calculates the skew-symmetric matrix of a vector.
Vector crossP (const Vector &_v1, const Vector &_v2)
 Calculates the cross product of 2 vectors.

Variables

const int MatrixIndexBase = 1
const int VectorIndexBase = 1
const int MatrixRowsIndex = 1
const int MatrixColsIndex = 2


Typedef Documentation

typedef CAMdoubleMatrix O_SESSAME::Matrix
 

< Encapsulation of CAMdoubleMatrix class

Definition at line 28 of file Matrix.h.

Referenced by ab_Fmatrix(), ab_Hmatrix(), ab_measurementRHSFunc(), ab_Qmatrix(), ab_Rmatrix(), O_SESSAME::Plot::AddPlot(), Att_Fmatrix(), Att_Hmatrix(), Att_Qmatrix(), Att_Rmatrix(), Att_stateRHSFunc(), AttitudeServer(), AttitudeTrajectory(), AttituteDynamics(), AttituteDynamics_QuaternionAngVel(), ChangeAttitude(), ControlTorques(), convertMatrix(), O_SESSAME::DirectionCosineMatrix::DirectionCosineMatrix(), OrbitObserver::DirectionCosMatrix1Axis(), OrbitObserver::DirectionCosMatrix2Axis(), OrbitObserver::DirectionCosMatrix3Axis(), OrbitObserver::ECEF2NEDVelocity(), eigenValues(), Euler_Fmatrix(), Euler_Hmatrix(), Euler_Qmatrix(), Euler_Rmatrix(), Euler_stateRHSFunc(), O_SESSAME::eye(), Controller::FindA(), Controller::FindMOI_sw(), Fmatrix(), triadObserver::GetAttitude(), KalmanFilter::GetCovarianceMatrix(), SequentialFilterHistory::GetHistory(), O_SESSAME::OrbitHistory::GetHistory(), KalmanFilterHistory::GetHistory(), O_SESSAME::History::GetHistory(), O_SESSAME::AttitudeHistory::GetHistory(), KalmanFilter::GetKalmanGainMatrix(), KalmanFilterHistory::GetKalmanHistory(), KalmanFilter::GetMeasurementCovarianceMatrix(), KalmanFilter::GetMeasurementJacobianMatrix(), Whorl::GetMOI(), O_SESSAME::Orbit::GetParameters(), O_SESSAME::Attitude::GetParameters(), O_SESSAME::Rotation::GetRotation(), O_SESSAME::OrbitHistory::GetState(), O_SESSAME::AttitudeHistory::GetState(), KalmanFilter::GetStateJacobianMatrix(), KalmanFilter::GetSystemProcessNoiseMatrix(), GravityGradientTorque(), greatestEigenValue(), Hmatrix(), Whorl::Initialize(), SingleAxisController::Initialize(), MWCMGController::Initialize(), MRPTracking::Initialize(), DefaultObserver::Initialize(), DefaultController::Initialize(), AttitudeObserver::Initialize(), atterrbiasObserver::Initialize(), AngularRateController::Initialize(), O_SESSAME::RungeKuttaIntegrator::Integrate(), O_SESSAME::LinearInterpolator::Interpolate(), KalmanFilter::KalmanFilter(), O_SESSAME::LinearInterpolator::LinearInterpolator(), LKFCalcualteKalmanGain(), LKFCovarianceMatrixPropagator(), LKFCovarianceMeasurementUpdate(), LKFStateMeasurementUpdate(), LKFStatePropagator(), main(), matrixDet(), matrixDet2x2(), matrixInv3x3(), QuaternionEKFObserver::MeasurementUpdate(), QuaternionEKFObserver::MurrellAlgorithm(), myAttitudeStateConvFunc(), myOrbitStateConvFunc(), OrbitObserver::NED2ECEFVelocity(), norm2(), O_SESSAME::Quaternion::operator+(), O_SESSAME::Quaternion::operator-(), otimes(), param_Euler_Ematrix(), Plot(), O_SESSAME::Plot::Plot(), O_SESSAME::Plot2D(), O_SESSAME::Plot3D(), PositionVelocityConvFunc(), O_SESSAME::Attitude::Propagate(), O_SESSAME::Propagator::PropagateAttitude(), O_SESSAME::CombinedNumericPropagator::PropagateAttitude(), O_SESSAME::Propagator::PropagateOrbit(), O_SESSAME::CombinedNumericPropagator::PropagateOrbit(), qdot(), Qmatrix(), QuaternionAngVelConvFunc(), QuaternionDynamics(), QuaternionKinematics(), Controller::ReferenceModelSC(), Controller::ReferenceTrajectory(), Rmatrix(), O_SESSAME::Rotation::Rotation(), slidingModeControlMRPMW::Run(), MWCMGController::Run(), MRPTracking::Run(), DefaultController::Run(), AngularRateController::Run(), O_SESSAME::Quaternion::Set(), O_SESSAME::DirectionCosineMatrix::Set(), O_SESSAME::Rotation::Set(), KalmanFilter::SetCovarianceMatrix(), KalmanFilter::SetKalmanGainMatrix(), KalmanFilter::SetMeasurementCovarianceMatrix(), KalmanFilter::SetMeasurementJacobianMatrix(), O_SESSAME::Orbit::SetParameters(), O_SESSAME::Attitude::SetParameters(), O_SESSAME::Keplerian::SetPositionVelocity(), KalmanFilter::SetStateJacobianMatrix(), KalmanFilter::SetSystemProcessNoiseMatrix(), SetupAttitude(), SetupEnvironment(), simulatorInertia(), QuaternionEKFObserver::SingleMeasurement(), O_SESSAME::skew(), SMD_Fmatrix(), SMD_Hmatrix(), SMD_Qmatrix(), SMD_Rmatrix(), state_Euler_Fmatrix(), state_Euler_Hmatrix(), state_Euler_Qmatrix(), state_Euler_Rmatrix(), state_Euler_stateRHSFunc(), QuaternionEKFObserver::StateCovarianceUpdate(), QuaternionEKFObserver::StateTransitionMatrix(), testRKFunc(), testRKFunc2(), and TwoBodyDynamics().

typedef CAMdoubleVector O_SESSAME::Vector
 

< Encapsulation of CAMdoubleVector class

Definition at line 29 of file Matrix.h.

Referenced by ab_Fmatrix(), ab_Hmatrix(), ab_measurementRHSFunc(), ab_stateRHSFunc(), Observer::AccelerationCorrection(), WhorlHistory::AppendHistory(), O_SESSAME::AttitudeHistory::AppendHistory(), Att_Fmatrix(), Att_measurementRHSFunc(), Att_stateRHSFunc(), AttitudeServer(), O_SESSAME::AttitudeState::AttitudeState(), AttitudeTrajectory(), AttituteDynamics(), AttituteDynamics_QuaternionAngVel(), O_SESSAME::ObjectFunctor< Environment >::Call(), O_SESSAME::SpecificFunctor::Call(), OrbitController::cals(), ChangeAttitude(), ChangeEnvironment(), ChangeOrbit(), COENaaszController::COENaasz(), ControlTorques(), convertVector(), O_SESSAME::crossP(), O_SESSAME::DirectionCosineMatrix::DirectionCosineMatrix(), O_SESSAME::TestKeplerian::DisplayPositionVelocity(), DragForceFunction(), OrbitObserver::ECEF2NEDVelocity(), OrbitObserver::ECEF2WGS84(), OrbitObserver::ECEFPosition2WGS84(), eigenValues(), IteratedExtendedKalmanFilter::EstimateState(), Euler_Fmatrix(), Euler_measurementRHSFunc(), Euler_stateRHSFunc(), O_SESSAME::LinearInterpolator::Evaluate(), O_SESSAME::EnvFunction::Evaluate(), RG_Message::FillVector(), Controller::FindA(), COENaaszController::Gains(), O_SESSAME::AttitudeState::GetAngularVelocity(), triadObserver::GetAttitude(), Whorl::GetCGVector(), ControlMomentGyro::GetCMGAxis(), Whorl::GetControl(), Whorl::GetControlError(), O_SESSAME::Orbit::GetControlForces(), O_SESSAME::Attitude::GetControlTorques(), SequentialFilter::GetControlVector(), GPSObserver::GetECEF(), Whorl::GetECI(), GPSObserver::GetECI(), KalmanFilter::GetEstimatedMeasurements(), ExtendedKalmanFilter::GetEstimatedMeasurements(), O_SESSAME::Quaternion::GetEulerAngles(), O_SESSAME::ModifiedRodriguezParameters::GetEulerAngles(), O_SESSAME::DirectionCosineMatrix::GetEulerAngles(), O_SESSAME::Rotation::GetEulerAngles(), O_SESSAME::Quaternion::GetEulerAxisAngle(), O_SESSAME::ModifiedRodriguezParameters::GetEulerAxisAngle(), O_SESSAME::DirectionCosineMatrix::GetEulerAxisAngle(), O_SESSAME::Rotation::GetEulerAxisAngle(), O_SESSAME::Environment::GetForces(), SequentialFilterHistory::GetIterationHistory(), IteratedExtendedKalmanFilterHistory::GetIterationHistory(), DMU::GetLocation(), DMUTemperatureSensor::GetLocation(), DMURateGyro::GetLocation(), DMUAccelerometer::GetLocation(), Device::GetLocation(), O_SESSAME::TiltedDipoleMagneticModel::GetMagneticField(), SequentialFilter::GetMeasurementVector(), Whorl::GetMRP(), Whorl::GetOmegaBL(), O_SESSAME::OrbitState::GetOrbitAngularMomentum(), Whorl::GetOrbitControl(), Whorl::GetParameter(), SequentialFilter::GetParameterVector(), O_SESSAME::PositionVelocity::GetPositionVelocity(), O_SESSAME::Keplerian::GetPositionVelocity(), O_SESSAME::Keplerian::GetPositionVelocityPQW(), Whorl::GetQuaternion(), Magnetometer::GetRawVectorMeasurement(), Whorl::GetReferenceMRP(), Whorl::GetReferenceOmegaBL(), Whorl::GetReferenceQuaternion(), O_SESSAME::Rotation::GetRotation(), TiltSensor::GetSensorLocation(), TiltSensor::GetSensorToBodyQuaternion(), PhysicalTiltSensor::GetSensorToBodyQuaternion(), DMU::GetSensorToBodyQuaternion(), DMURateGyro::GetSensorToBodyQuaternion(), DMUAccelerometer::GetSensorToBodyQuaternion(), WhorlSim::GetState(), Whorl::GetState(), O_SESSAME::PositionVelocity::GetState(), O_SESSAME::OrbitState::GetState(), OrbitPropObserver::GetState(), O_SESSAME::OrbitHistory::GetState(), O_SESSAME::Keplerian::GetState(), O_SESSAME::AttitudeState::GetState(), O_SESSAME::AttitudeHistory::GetState(), ExtendedKalmanFilter::GetStateDot(), SequentialFilter::GetStateVector(), O_SESSAME::Environment::GetTorques(), VisualVector::GetVectorMeasurement(), Magnetometer::GetVectorMeasurement(), GPSObserver::GetWGS84(), MomentumWheel::GetWheelAxis(), GravityForceFunction(), GravityGradientTorque(), greatestEigenValue(), Whorl::Initialize(), DMU::Initialize(), OpenLoopMWController::Initialize(), MomentumWheel::Initialize(), COENaaszController::Initialize(), AttitudeObserver::Initialize(), atterrbiasObserver::Initialize(), O_SESSAME::RungeKuttaIntegrator::Integrate(), O_SESSAME::LinearInterpolator::Interpolate(), O_SESSAME::Keplerian::Keplerian(), O_SESSAME::TestKeplerian::Keplerian2ECI2Keplerian(), O_SESSAME::LinearInterpolator::LinearInterpolator(), LKFCovarianceMatrixPropagator(), LKFCovarianceMeasurementUpdate(), LKFStateMeasurementUpdate(), LKFStatePropagator(), Magnetometer::Magnetometer(), main(), O_SESSAME::OsculatingOrbitalElements::Mapping(), O_SESSAME::ModifiedRodriguezParameters::ModifiedRodriguezParameters(), AttitudeModels::MRPKinematic(), QuaternionEKFObserver::MurrellAlgorithm(), myAttitudeStateConvFunc(), myOrbitStateConvFunc(), OrbitObserver::NED2ECEFVelocity(), norm2(), NullFunctor(), O_SESSAME::DirectionCosineMatrix::operator *(), O_SESSAME::Rotation::operator *(), RG_Message::operator Vector(), OrbitForcesFunctor(), OrbitForcesWithDragFunctor(), otimes(), param_Euler_Ematrix(), OrbitPropObserver::ParseState(), O_SESSAME::PositionVelocity::PositionVelocity(), PositionVelocityConvFunc(), Propagate(), O_SESSAME::NumericPropagator::Propagate(), O_SESSAME::CombinedNumericPropagator::Propagate(), O_SESSAME::Propagator::PropagateAttitude(), O_SESSAME::CombinedNumericPropagator::PropagateAttitude(), O_SESSAME::Propagator::PropagateOrbit(), O_SESSAME::CombinedNumericPropagator::PropagateOrbit(), qdot(), O_SESSAME::Quaternion::Quaternion(), QuaternionAngVelConvFunc(), QuaternionDynamics(), AttitudeModels::QuaternionKinematic(), QuaternionKinematics(), Controller::ReferenceModelSC(), Controller::ReferenceTrajectory(), RG_Message::RG_Message(), O_SESSAME::Rotation::Rotation(), triadObserver::Run(), testController::Run(), slidingModeControlMRPMW::Run(), SingleAxisController::Run(), MWCMGController::Run(), MRPTracking::Run(), DefaultObserver::Run(), DefaultController::Run(), COENaaszController::Run(), AttitudeObserver::Run(), atterrbiasObserver::Run(), AngularRateController::Run(), RungeKutta(), RungeKuttaSolve(), Controller::Saturation(), O_SESSAME::Quaternion::Set(), O_SESSAME::ModifiedRodriguezParameters::Set(), O_SESSAME::DirectionCosineMatrix::Set(), O_SESSAME::Rotation::Set(), triadObserver::SetAccelerometerBodyVector(), triadObserver::SetAccelerometerInertialVector(), Whorl::SetAngularRateError(), O_SESSAME::AttitudeState::SetAngularVelocity(), Whorl::SetControl(), O_SESSAME::Orbit::SetControlForces(), O_SESSAME::Attitude::SetControlTorques(), SequentialFilter::SetControlVector(), Whorl::SetECI(), O_SESSAME::Keplerian::SetKeplerianRepresentationEccentricAnomaly(), O_SESSAME::Keplerian::SetKeplerianRepresentationMeanAnomaly(), O_SESSAME::Keplerian::SetKeplerianRepresentationTrueAnomaly(), DMU::SetLocation(), Device::SetLocation(), triadObserver::SetMagnetometerBodyVector(), triadObserver::SetMagnetometerInertialVector(), ExtendedKalmanFilter::SetMeasurementRHS(), SequentialFilter::SetMeasurementVector(), Whorl::SetMRPError(), Whorl::SetOrbitControl(), Whorl::SetParameter(), SequentialFilter::SetParameterVector(), O_SESSAME::PositionVelocity::SetPositionVelocity(), O_SESSAME::Keplerian::SetPositionVelocity(), Whorl::SetReferenceOmegaBL(), Whorl::SetReferenceQuaternion(), DMU::SetSensorToBodyQuaternions(), Whorl::SetState(), O_SESSAME::PositionVelocity::SetState(), O_SESSAME::OrbitState::SetState(), O_SESSAME::Keplerian::SetState(), O_SESSAME::AttitudeState::SetState(), ExtendedKalmanFilter::SetStateRHS(), SequentialFilter::SetStateVector(), SetupAttitude(), SetupOrbit(), MomentumWheel::SetWheelAxis(), ControlMomentGyro::SetWheelAxis(), PhysicalMomentumWheel::SetWheelSpeedCoefficients(), MomentumWheel::SetWheelSpeedCoefficients(), Controller::SetWheelTorque(), Controller::Sign(), SimpleController(), QuaternionEKFObserver::SingleMeasurement(), SolarRadiationPressureForceFunction(), state_Euler_Fmatrix(), state_Euler_measurementRHSFunc(), state_Euler_stateRHSFunc(), QuaternionEKFObserver::StateCovarianceUpdate(), QuaternionEKFObserver::StateTransitionMatrix(), O_SESSAME::ModifiedRodriguezParameters::Switch(), testRKFunc(), testRKFunc2(), ThirdBodyForceDisturbance(), Thruster::Thruster(), OrbitController::thruster(), TiltSensor::TiltSensor(), TwoBodyDynamics(), O_SESSAME::Vabs(), OrbitObserver::WGS2ECEFPosition(), OrbitObserver::WGS842ECEF(), and Controller::WheelSaturation().


Function Documentation

Vector crossP const Vector _v1,
const Vector _v2
[inline]
 

Calculates the cross product of 2 vectors.

Equation: /f$ v_3 = v_1 v_2 = v_1/f$

Parameters:
_inVector Vector to calculate the 2-norm of.
Returns:
Cross product of 2 vectors.
Todo:
Implement crossP as part of Vector or CAMdoubleVector class

Definition at line 149 of file Matrix.h.

References O_SESSAME::skew(), and O_SESSAME::Vector.

Referenced by OrbitController::cals(), triadObserver::GetAttitude(), O_SESSAME::ModifiedRodriguezParameters::operator+(), O_SESSAME::ModifiedRodriguezParameters::operator-(), and O_SESSAME::Keplerian::SetPositionVelocity().

Matrix eye int  _rowColumns  )  [inline]
 

Creates an square identity matrix of specified size.

Parameters:
_rowColumns Number of rows and columns to size matrix (will be a square matrix).
Todo:
Implement eye as part of Vector or CAMdoubleVector class

Definition at line 56 of file Matrix.h.

References O_SESSAME::Matrix, and CAMmatrixBase::setToValue().

Referenced by ab_Fmatrix(), ab_Hmatrix(), ab_Qmatrix(), ab_Rmatrix(), ab_stateRHSFunc(), AttituteDynamics(), ChangeAttitude(), ControlTorques(), O_SESSAME::DirectionCosineMatrix::DirectionCosineMatrix(), OrbitFrameIJK::GetRotation2IJK(), OrbitFrameIJK::GetRotationFromIJK(), atterrbiasObserver::Initialize(), LKFCovarianceMatrixPropagator(), LKFCovarianceMeasurementUpdate(), LKFStatePropagator(), main(), AttitudeModels::MRPKinematic(), otimes(), qdot(), QuaternionKinematics(), slidingModeControlMRPMW::Run(), O_SESSAME::DirectionCosineMatrix::Set(), SetupAttitude(), QuaternionEKFObserver::SingleMeasurement(), state_Euler_Hmatrix(), state_Euler_Qmatrix(), and state_Euler_Rmatrix().

double norm2 const Vector _inVector  )  [inline]
 

Calculates the 2-norm of the vector (square-root of the sum of the squares).

Todo:
Implement norm2 as part of Vector or CAMdoubleVector class
Parameters:
_inVector Vector to calculate the 2-norm of.
Returns:
Square-root of the sum of squares of elements in vector.

Definition at line 82 of file Matrix.h.

References CAMvectorBase::getIndexCount().

Referenced by AttituteDynamics(), OrbitController::cals(), QuaternionEKFObserver::CheckMagnetometerMeasurement(), DragForceFunction(), O_SESSAME::TiltedDipoleMagneticModel::GetMagneticField(), O_SESSAME::OrbitState::GetOrbitAngularMomentum(), GravityForceFunction(), GravityGradientTorque(), slidingModeControlMRPMW::Initialize(), AttitudeModels::MRPKinematic(), O_SESSAME::normalize(), O_SESSAME::ModifiedRodriguezParameters::operator+(), O_SESSAME::ModifiedRodriguezParameters::operator-(), OrbitForcesFunctor(), OrbitForcesWithDragFunctor(), triadObserver::Run(), SingleAxisController::Run(), MWCMGController::Run(), O_SESSAME::Keplerian::SetPositionVelocity(), O_SESSAME::ModifiedRodriguezParameters::ShadowSet(), SolarRadiationPressureForceFunction(), QuaternionEKFObserver::StateTransitionMatrix(), O_SESSAME::ModifiedRodriguezParameters::Switch(), ThirdBodyForceDisturbance(), and OrbitController::thruster().

void normalize Vector _inVector  )  [inline]
 

Normalizes a vector.

Parameters:
_inVector Vector to be normalized.
Todo:
Implement normalize as part of Vector or CAMdoubleVector class

Definition at line 94 of file Matrix.h.

References O_SESSAME::norm2().

Referenced by triadObserver::GetAttitude(), O_SESSAME::Quaternion::Normalize(), triadObserver::Parse(), QuaternionEKFObserver::Parse(), and QuaternionEKFObserver::StateCovarianceUpdate().

double normInf const Vector _inVector  )  [inline]
 

Calculates the Infinity-norm of the vector (largest value of the components).

Parameters:
_inVector Vector to calculate the 2-norm of.
Returns:
Absolute value of maximum component in vector.
Todo:
Implement normInf as part of Vector or CAMdoubleVector class

Definition at line 105 of file Matrix.h.

References CAMvectorBase::maxAbs().

Referenced by O_SESSAME::Quaternion::Set().

Matrix skew const Vector _inVector  )  [inline]
 

Calculates the skew-symmetric matrix of a vector.

Equation: /f[ {v^{}} = {bmatrix} 0 & -v_3 & v_2\ v_3 & 0 & -v_1\ -v_2 & v_1 & 0 {bmatrix} /f]

Parameters:
_inVector Vector to calculate the skew-symmetric matrix of.
Returns:
Skew-symmetric matrix (3x3).
Todo:
Implement skew as part of Vector or CAMdoubleVector class

Definition at line 124 of file Matrix.h.

References O_SESSAME::Matrix, O_SESSAME::MatrixIndexBase, CAMmatrixBase::setToValue(), and O_SESSAME::VectorIndexBase.

Referenced by ab_Fmatrix(), ab_Hmatrix(), ab_measurementRHSFunc(), ab_stateRHSFunc(), Observer::AccelerationCorrection(), Att_Fmatrix(), Att_stateRHSFunc(), AttituteDynamics(), AttituteDynamics_QuaternionAngVel(), ControlTorques(), O_SESSAME::crossP(), Euler_Fmatrix(), Euler_stateRHSFunc(), O_SESSAME::OrbitState::GetOrbitAngularMomentum(), GravityGradientTorque(), QuaternionEKFObserver::MeasurementUpdate(), AttitudeModels::MRPKinematic(), otimes(), qdot(), QuaternionDynamics(), AttitudeModels::QuaternionKinematic(), QuaternionKinematics(), slidingModeControlMRPMW::Run(), SingleAxisController::Run(), MWCMGController::Run(), MRPTracking::Run(), DefaultController::Run(), AngularRateController::Run(), QuaternionEKFObserver::SingleMeasurement(), state_Euler_Fmatrix(), state_Euler_stateRHSFunc(), QuaternionEKFObserver::StateCovarianceUpdate(), and QuaternionEKFObserver::StateTransitionMatrix().

double trace const Matrix _inMatrix  )  [inline]
 

Calculates the trace of matrix (sum of elements along diagonal).

Parameters:
_inMatrix Matrix to have trace calculated.
Todo:
Implement trace as part of Vector or CAMdoubleVector class

Definition at line 69 of file Matrix.h.

Referenced by O_SESSAME::DirectionCosineMatrix::GetEulerAxisAngle(), and O_SESSAME::Quaternion::Set().

Vector Vabs Vector  _vector  )  [inline]
 

Returns the absolute value of a vector.

Parameters:
_vector 

Definition at line 34 of file Matrix.h.

References CAMvectorBase::getIndexCount(), and O_SESSAME::Vector.

Referenced by slidingModeControlMRPMW::Run().


Variable Documentation

const int O_SESSAME::MatrixColsIndex = 2
 

< Value referring to the "columns" index

Definition at line 27 of file Matrix.h.

Referenced by O_SESSAME::LinearInterpolator::LinearInterpolator(), myOrbitStateConvFunc(), PositionVelocityConvFunc(), O_SESSAME::CombinedNumericPropagator::PropagateAttitude(), and O_SESSAME::CombinedNumericPropagator::PropagateOrbit().

const int O_SESSAME::MatrixIndexBase = 1
 

< Beginning index of Matrix class

Definition at line 24 of file Matrix.h.

Referenced by O_SESSAME::Plot::AddPlot(), AttituteDynamics(), O_SESSAME::DirectionCosineMatrix::GetEulerAxisAngle(), SequentialFilterHistory::GetHistory(), O_SESSAME::OrbitHistory::GetHistory(), O_SESSAME::History::GetHistory(), O_SESSAME::AttitudeHistory::GetHistory(), IteratedExtendedKalmanFilterHistory::GetIterationHistory(), KalmanFilterHistory::GetKalmanHistory(), O_SESSAME::RungeKuttaIntegrator::Integrate(), main(), myOrbitStateConvFunc(), O_SESSAME::DirectionCosineMatrix::Normalize(), O_SESSAME::Quaternion::operator+(), O_SESSAME::Quaternion::operator-(), Plot(), O_SESSAME::Plot2D(), PositionVelocityConvFunc(), O_SESSAME::CombinedNumericPropagator::PropagateAttitude(), O_SESSAME::CombinedNumericPropagator::PropagateOrbit(), QuaternionDynamics(), QuaternionKinematics(), O_SESSAME::R1(), O_SESSAME::R2(), O_SESSAME::R3(), O_SESSAME::Quaternion::Set(), O_SESSAME::DirectionCosineMatrix::Set(), and O_SESSAME::skew().

const int O_SESSAME::MatrixRowsIndex = 1
 

< Value referring to the "rows" index

Definition at line 26 of file Matrix.h.

const int O_SESSAME::VectorIndexBase = 1
 

< Beginning index of Vector class

Definition at line 25 of file Matrix.h.

Referenced by AttituteDynamics(), AttituteDynamics_QuaternionAngVel(), ChangeOrbit(), DragForceFunction(), O_SESSAME::Quaternion::GetEulerAxisAngle(), O_SESSAME::DirectionCosineMatrix::GetEulerAxisAngle(), O_SESSAME::Keplerian::GetPositionVelocity(), O_SESSAME::Keplerian::GetPositionVelocityPQW(), O_SESSAME::Rotation::GetRotation(), O_SESSAME::PositionVelocity::GetState(), O_SESSAME::AttitudeState::GetState(), GravityForceFunction(), Whorl::Initialize(), O_SESSAME::LinearInterpolator::Interpolate(), main(), O_SESSAME::OsculatingOrbitalElements::Mapping(), O_SESSAME::Quaternion::operator+(), O_SESSAME::Quaternion::operator-(), OrbitForcesFunctor(), OrbitForcesWithDragFunctor(), O_SESSAME::Quaternion::Quaternion(), QuaternionKinematics(), O_SESSAME::Quaternion::Set(), O_SESSAME::ModifiedRodriguezParameters::Set(), O_SESSAME::DirectionCosineMatrix::Set(), O_SESSAME::Keplerian::SetKeplerianRepresentationEccentricAnomaly(), O_SESSAME::Keplerian::SetKeplerianRepresentationMeanAnomaly(), O_SESSAME::Keplerian::SetPositionVelocity(), O_SESSAME::PositionVelocity::SetState(), SetupOrbit(), O_SESSAME::skew(), ThirdBodyForceDisturbance(), and TwoBodyDynamics().


Generated on Wed Sep 5 12:54:32 2007 for DSACSS Operational Code by  doxygen 1.3.9.1