|
typedef solvers::ResultData | ResultData |
|
typedef double | value_type |
|
typedef Eigen::Matrix< value_type, 3, 3 > | Matrix3 |
|
typedef Eigen::Matrix< value_type, 6, 3 > | Matrix63 |
|
typedef Eigen::Matrix< value_type, 3, 9 > | Matrix39 |
|
typedef Eigen::Matrix< value_type, Eigen::Dynamic, 3 > | MatrixX3 |
|
typedef Eigen::Matrix< value_type, Eigen::Dynamic, Eigen::Dynamic > | MatrixXX |
|
typedef centroidal_dynamics::Vector3 | Vector3 |
|
typedef centroidal_dynamics::Vector6 | Vector6 |
|
typedef centroidal_dynamics::VectorX | VectorX |
|
typedef Eigen::Ref< Vector3 > | Ref_vector3 |
|
typedef Eigen::Ref< VectorX > | Ref_vectorX |
|
typedef Eigen::Ref< MatrixX3 > | Ref_matrixX3 |
|
typedef Eigen::Ref< MatrixXX > | Ref_matrixXX |
|
typedef const Eigen::Ref< const Vector3 > & | Cref_vector3 |
|
typedef const Eigen::Ref< const Vector6 > & | Cref_vector6 |
|
typedef const Eigen::Ref< const VectorX > & | Cref_vectorX |
|
typedef const Eigen::Ref< const MatrixXX > & | Cref_matrixXX |
|
typedef const Eigen::Ref< const MatrixX3 > & | Cref_matrixX3 |
|
typedef Matrix63 | matrix6_t |
|
typedef Vector6 | point6_t |
|
typedef Matrix3 | matrix3_t |
|
typedef Vector3 | point3_t |
|
typedef Eigen::Vector3d | point_t |
|
typedef const Eigen::Ref< const point_t > & | point_t_tC |
|
typedef std::pair< matrix6_t, point6_t > | waypoint6_t |
| waypoint_t a waypoint is composed of a 6*3 matrix that depend on the variable x, and of a 6d vector independent of x, such that each control point of the target bezier curve is given by pi = wix * x + wis
|
|
typedef std::pair< matrix3_t, point3_t > | waypoint3_t |
|
typedef std::pair< Matrix39, point3_t > | waypoint9_t |
|
typedef ndcurves::bezier_curve< double, double, true, point_t > | bezier_t |
|
typedef ndcurves::bezier_curve< double, double, true, waypoint_t > | bezier_wp_t |
|
typedef ndcurves::bezier_curve< double, double, true, point6_t > | bezier6_t |
|
typedef std::vector< std::pair< double, int > > | T_time |
|
typedef T_time::const_iterator | CIT_time |
|
typedef std::pair< double, point3_t > | coefs_t |
|
typedef coefs_t(* | evalCurveAtTime) (const std::vector< point_t > &pi, double t) |
|
typedef std::map< ConstraintFlag, evalCurveAtTime > | T_evalCurveAtTime |
|
typedef T_evalCurveAtTime::const_iterator | CIT_evalCurveAtTime |
|
typedef coefs_t(* | evalAccCurveAtTime) (const std::vector< point_t > &pi, double T, double t) |
|
typedef std::map< ConstraintFlag, evalAccCurveAtTime > | T_evalAccCurveAtTime |
|
typedef T_evalAccCurveAtTime::const_iterator | CIT_evalAccCurveAtTime |
|
typedef waypoint_t(* | evalCurveWaypointAtTime) (const std::vector< point_t > &pi, double t) |
|
typedef std::map< ConstraintFlag, evalCurveWaypointAtTime > | T_evalCurveWaypointAtTime |
|
typedef T_evalCurveWaypointAtTime::const_iterator | CIT_evalCurveWaypointAtTime |
|
typedef waypoint_t(* | evalVelCurveWaypointAtTime) (const std::vector< point_t > &pi, const double T, double t) |
|
typedef std::map< ConstraintFlag, evalVelCurveWaypointAtTime > | T_evalVelCurveWaypointAtTime |
|
typedef T_evalVelCurveWaypointAtTime::const_iterator | CIT_evalVelCurveWaypointAtTime |
|
typedef waypoint_t(* | evalAccCurveWaypointAtTime) (const std::vector< point_t > &pi, const double T, double t) |
|
typedef std::map< ConstraintFlag, evalAccCurveWaypointAtTime > | T_evalAccCurveWaypointAtTime |
|
typedef T_evalAccCurveWaypointAtTime::const_iterator | CIT_evalAccCurveWaypointAtTime |
|
typedef waypoint_t(* | evalJerkCurveWaypointAtTime) (const std::vector< point_t > &pi, const double T, double t) |
|
typedef std::map< ConstraintFlag, evalJerkCurveWaypointAtTime > | T_evalJerkCurveWaypointAtTime |
|
typedef T_evalJerkCurveWaypointAtTime::const_iterator | CIT_evalJerkCurveWaypointAtTime |
|
typedef std::vector< point_t >(* | compConsWp) (const ProblemData &pData, double T) |
|
typedef std::map< ConstraintFlag, compConsWp > | T_compConsWp |
|
typedef T_compConsWp::const_iterator | CIT_compConsWp |
|
typedef std::vector< waypoint_t >(* | compVelWp) (const ProblemData &pData, double T, std::vector< bezier_t::point_t > pi) |
|
typedef std::map< ConstraintFlag, compVelWp > | T_compVelWp |
|
typedef T_compVelWp::const_iterator | CIT_compVelWp |
|
typedef std::vector< waypoint_t >(* | compAccWp) (const ProblemData &pData, double T, std::vector< bezier_t::point_t > pi) |
|
typedef std::map< ConstraintFlag, compAccWp > | T_compAccWp |
|
typedef T_compAccWp::const_iterator | CIT_compAccWp |
|
typedef std::vector< waypoint_t >(* | compJerkWp) (const ProblemData &pData, double T, std::vector< bezier_t::point_t > pi) |
|
typedef std::map< ConstraintFlag, compJerkWp > | T_compJerkWp |
|
typedef T_compJerkWp::const_iterator | CIT_compJerkWp |
|
typedef bezier_wp_t::t_point_t(* | compWp) (const ProblemData &pData, double T) |
|
typedef std::map< ConstraintFlag, compWp > | T_compWp |
|
typedef T_compWp::const_iterator | CIT_compWp |
|
typedef coefs_t(* | compFinalVelP) (const ProblemData &pData, double T) |
|
typedef std::map< ConstraintFlag, compFinalVelP > | T_compFinalVelP |
|
typedef T_compFinalVelP::const_iterator | CIT_compFinalVelP |
|
typedef std::pair< MatrixXX, VectorX >(* | compVelCost) (const ProblemData &pData, double T, std::vector< bezier_t::point_t > pi) |
|
typedef std::map< ConstraintFlag, compVelCost > | T_compVelCost |
|
typedef T_compVelCost::const_iterator | CIT_compVelCost |
|
|
BEZIER_COM_TRAJ_DLLAPI std::vector< waypoint6_t > | ComputeDiscretizedWaypoints (const std::vector< waypoint6_t > &wps, const std::vector< ndcurves::Bern< double > > &bernstein, int numSteps) |
| ComputeDiscretizedWaypoints Given the waypoints defining a bezier curve, computes a discretization of the curve.
|
|
BEZIER_COM_TRAJ_DLLAPI std::pair< MatrixXX, VectorX > | compute6dControlPointInequalities (const ContactData &cData, const std::vector< waypoint6_t > &wps, const std::vector< waypoint6_t > &wpL, const bool useAngMomentum, bool &fail) |
| compute6dControlPointInequalities Given linear and angular control waypoints, compute the inequality matrices A and b, A x <= b that constrain the desired control point x.
|
|
BEZIER_COM_TRAJ_DLLAPI std::pair< MatrixXX, VectorX > | compute6dControlPointEqualities (const ContactData &cData, const std::vector< waypoint6_t > &wps, const std::vector< waypoint6_t > &wpL, const bool useAngMomentum, bool &fail) |
| compute6dControlPointEqualities Given linear and angular control waypoints, compute the equality matrices D and d, D [x; Beta]' = d that constrain the desired control point x and contact forces Beta.
|
|
BEZIER_COM_TRAJ_DLLAPI ResultData | solve (Cref_matrixXX A, Cref_vectorX b, Cref_matrixXX H, Cref_vectorX g, Cref_vectorX initGuess, Cref_vectorX minBounds, Cref_vectorX maxBounds, const solvers::SolverType solver=solvers::SOLVER_QUADPROG) |
| solve x' h x + 2 g' x, subject to A*x <= b using quadprog
|
|
BEZIER_COM_TRAJ_DLLAPI ResultData | solve (Cref_matrixXX A, Cref_vectorX b, Cref_matrixXX D, Cref_vectorX d, Cref_matrixXX H, Cref_vectorX g, Cref_vectorX initGuess, const solvers::SolverType solver=solvers::SOLVER_QUADPROG) |
| solve x' h x + 2 g' x, subject to A*x <= b and D*x = c using quadprog
|
|
BEZIER_COM_TRAJ_DLLAPI ResultData | solve (const std::pair< MatrixXX, VectorX > &Ab, const std::pair< MatrixXX, VectorX > &Hg, const VectorX &init, const solvers::SolverType solver=solvers::SOLVER_QUADPROG) |
| solve x' h x + 2 g' x, subject to A*x <= b using quadprog, with x of fixed dimension 3
|
|
BEZIER_COM_TRAJ_DLLAPI ResultData | solve (const std::pair< MatrixXX, VectorX > &Ab, const std::pair< MatrixXX, VectorX > &Dd, const std::pair< MatrixXX, VectorX > &Hg, Cref_vectorX minBounds, Cref_vectorX maxBounds, const VectorX &init, const solvers::SolverType solver=solvers::SOLVER_QUADPROG) |
| solve x' h x + 2 g' x, subject to A*x <= b and D*x = c using quadprog, with x of fixed dimension 3
|
|
template<typename Point > |
BEZIER_COM_TRAJ_DLLAPI std::vector< std::pair< double, Point > > | computeDiscretizedWaypoints (const ProblemData &pData, double T, const T_time &timeArray) |
|
template<typename Point > |
BEZIER_COM_TRAJ_DLLAPI std::vector< std::pair< double, Point > > | computeDiscretizedAccelerationWaypoints (const ProblemData &pData, double T, const T_time &timeArray) |
|
ConstraintFlag | operator~ (ConstraintFlag a) |
|
ConstraintFlag | operator| (ConstraintFlag a, ConstraintFlag b) |
|
ConstraintFlag | operator& (ConstraintFlag a, ConstraintFlag b) |
|
ConstraintFlag | operator^ (ConstraintFlag a, ConstraintFlag b) |
|
ConstraintFlag & | operator|= (ConstraintFlag &a, ConstraintFlag b) |
|
ConstraintFlag & | operator&= (ConstraintFlag &a, ConstraintFlag b) |
|
ConstraintFlag & | operator^= (ConstraintFlag &a, ConstraintFlag b) |
|
BEZIER_COM_TRAJ_DLLAPI ResultDataCOMTraj | solve0step (const ProblemData &pData, const std::vector< double > &Ts, const double timeStep=-1) |
| solve0step Tries to solve the 0-step capturability problem. Given the current contact phase, a COM position, and an initial velocity, tries to compute a feasible COM trajectory that stops the character without falling. In this specific implementation, the considered constraints are: init position and velocity, 0 velocity constraints (acceleration constraints are ignored)
|
|
BEZIER_COM_TRAJ_DLLAPI ResultDataCOMTraj | computeCOMTrajFixedSize (const ProblemData &pData, const VectorX &Ts, const unsigned int pointsPerPhase=3) |
| computeCOMTraj Tries to solve the one step problem : Given two or three contact phases, an initial and final com position and velocity, try to compute the CoM trajectory (as a Bezier curve) that connect them
|
|
BEZIER_COM_TRAJ_DLLAPI ResultDataCOMTraj | computeCOMTraj (const ProblemData &pData, const VectorX &Ts, const double timeStep=-1, const solvers::SolverType solver=solvers::SOLVER_QUADPROG) |
| computeCOMTraj Tries to solve the one step problem : Given two or three contact phases, an initial and final com position and velocity, try to compute the CoM trajectory (as a Bezier curve) that connect them
|
|
template<typename Path > |
ResultDataCOMTraj | solveEndEffector (const ProblemData &pData, const Path &path, const double T, const double weightDistance, bool useVelCost=true) |
| solveEndEffector Tries to produce a trajectory represented as a bezier curve that satisfy position, velocity and acceleration constraint for the initial and final point and that follow as close as possible the input trajectory
|
|
coefs_t | initCoefs () |
|
std::vector< bezier_t::point_t > | computeConstantWaypointsInitPredef (const ProblemData &pData, double T) |
|
std::vector< bezier_t::point_t > | computeConstantWaypointsGoalPredef (const ProblemData &pData, double T) |
|
void | computeConstraintsMatrix (const ProblemData &pData, const std::vector< waypoint_t > &wps_acc, const std::vector< waypoint_t > &wps_vel, const VectorX &acc_bounds, const VectorX &vel_bounds, MatrixXX &A, VectorX &b, const std::vector< waypoint_t > &wps_jerk=std::vector< waypoint_t >(), const VectorX &jerk_bounds=VectorX(DIM_POINT)) |
|
std::pair< MatrixXX, VectorX > | computeDistanceCostFunction (size_t numPoints, const ProblemData &pData, double T, std::vector< point3_t > pts_path) |
|
template<typename Path > |
std::pair< MatrixXX, VectorX > | computeDistanceCostFunction (size_t numPoints, const ProblemData &pData, double T, const Path &path) |
|
void | computeC_of_T (const ProblemData &pData, double T, ResultDataCOMTraj &res) |
|
void | computeVelCostFunctionDiscretized (int numPoints, const ProblemData &pData, double T, MatrixXX &H, VectorX &g) |
|
void | computeAccelerationCostFunctionDiscretized (int numPoints, const ProblemData &pData, double T, MatrixXX &H, VectorX &g) |
|
void | computeJerkCostFunctionDiscretized (int numPoints, const ProblemData &pData, double T, MatrixXX &H, VectorX &g) |
|
std::pair< MatrixXX, VectorX > | computeEndEffectorConstraints (const ProblemData &pData, const double T, std::vector< bezier_t::point_t > pi) |
|
template<typename Path > |
std::pair< MatrixXX, VectorX > | computeEndEffectorCost (const ProblemData &pData, const Path &path, const double T, const double weightDistance, bool, std::vector< bezier_t::point_t > pi) |
|
template<typename T > |
T | initwp () |
|
waypoint_t | initwp (const size_t rows, const size_t cols) |
|
waypoint_t | operator+ (const waypoint_t &w1, const waypoint_t &w2) |
|
waypoint_t | operator- (const waypoint_t &w1, const waypoint_t &w2) |
|
waypoint_t | operator* (const double k, const waypoint_t &w) |
|
waypoint_t | operator* (const waypoint_t &w, const double k) |
|
BEZIER_COM_TRAJ_DLLAPI std::vector< ndcurves::Bern< double > > | ComputeBersteinPolynoms (const unsigned int degree) |
| Compute the Bernstein polynoms for a given degree.
|
|
template<typename Bezier , typename Point > |
BEZIER_COM_TRAJ_DLLAPI Bezier | computeBezierCurve (const ConstraintFlag &flag, const double T, const std::vector< Point > &pi, const Point &x) |
| given the constraints of the problem, and a set of waypoints, return the bezier curve corresponding
|
|
T_time | computeDiscretizedTimeFixed (const VectorX &phaseTimings, const unsigned int pointsPerPhase) |
| computeDiscretizedTime build an array of discretized points in time, such that there is the same number of point in each phase. Doesn't contain t=0, is of size pointsPerPhase*phaseTimings.size()
|
|
T_time | computeDiscretizedTime (const VectorX &phaseTimings, const double timeStep) |
| computeDiscretizedTime build an array of discretized points in time, given the timestep. Doesn't contain t=0, is of size pointsPerPhase*phaseTimings.size()
|
|
void | printQHullFile (const std::pair< MatrixXX, VectorX > &Ab, VectorX intPoint, const std::string &fileName, bool clipZ=false) |
| write a polytope describe by A x <= b linear constraints in a given filename
|
|
BEZIER_COM_TRAJ_DLLAPI Matrix3 | skew (point_t_tC x) |
| skew symmetric matrix
|
|
int | Normalize (Ref_matrixXX A, Ref_vectorX b) |
| normalize inequality constraints
|
|
coefs_t | evaluateCurveAtTime (const ProblemData &pData, const std::vector< point_t > &pi, double t) |
| evaluateCurveAtTime compute the expression of the point on the curve c at t, defined by the waypoint pi and one free waypoint (x)
|
|
coefs_t | evaluateVelocityCurveAtTime (const ProblemData &pData, const std::vector< point_t > &pi, double T, double t) |
| evaluateVelocityCurveAtTime compute the expression of the point on the curve dc at t, defined by the waypoint pi and one free waypoint (x)
|
|
coefs_t | evaluateAccelerationCurveAtTime (const ProblemData &pData, const std::vector< point_t > &pi, double T, double t) |
| evaluateAccelerationCurveAtTime compute the expression of the point on the curve ddc at t, defined by the waypoint pi and one free waypoint (x)
|
|
coefs_t | evaluateJerkCurveAtTime (const ProblemData &pData, const std::vector< point_t > &pi, double T, double t) |
| evaluateAccelerationCurveAtTime compute the expression of the point on the curve ddc at t, defined by the waypoint pi and one free waypoint (x)
|
|
std::vector< point_t > | computeConstantWaypoints (const ProblemData &pData, double T) |
| computeConstantWaypoints compute the constant waypoints of c(t) defined by the constraints on initial and final states
|
|
bezier_wp_t::t_point_t | computeConstantWaypointsSymbolic (const ProblemData &pData, double T) |
| computeConstantWaypointsSymbolic compute the constant waypoints of c(t) defined by the constraints on initial and final states
|
|
std::vector< waypoint_t > | computeVelocityWaypoints (const ProblemData &pData, const double T, std::vector< bezier_t::point_t > pi=std::vector< bezier_t::point_t >()) |
| computeWwaypoints compute the constant waypoints of dc(t) defined by the constraints on initial and final states
|
|
std::vector< waypoint_t > | computeAccelerationWaypoints (const ProblemData &pData, const double T, std::vector< bezier_t::point_t > pi=std::vector< bezier_t::point_t >()) |
| computeWwaypoints compute the constant waypoints of ddc(t) defined by the constraints on initial and final states
|
|
std::vector< waypoint_t > | computeJerkWaypoints (const ProblemData &pData, const double T, std::vector< bezier_t::point_t > pi=std::vector< bezier_t::point_t >()) |
| computeWwaypoints compute the constant waypoints of dddc(t) defined by the constraints on initial and final states
|
|
waypoint_t | evaluateCurveWaypointAtTime (const ProblemData &pData, const std::vector< point_t > &pi, double t) |
| evaluateCurveAtTime compute the expression of the point on the curve c at t, defined by the waypoint pi and one free waypoint (x)
|
|
waypoint_t | evaluateVelocityCurveWaypointAtTime (const ProblemData &pData, const double T, const std::vector< point_t > &pi, double t) |
| evaluateCurveAtTime compute the expression of the point on the curve c at t, defined by the waypoint pi and one free waypoint (x)
|
|
waypoint_t | evaluateAccelerationCurveWaypointAtTime (const ProblemData &pData, const double T, const std::vector< point_t > &pi, double t) |
| evaluateCurveAtTime compute the expression of the point on the curve c at t, defined by the waypoint pi and one free waypoint (x)
|
|
waypoint_t | evaluateJerkCurveWaypointAtTime (const ProblemData &pData, const double T, const std::vector< point_t > &pi, double t) |
| evaluateCurveAtTime compute the expression of the point on the curve c at t, defined by the waypoint pi and one free waypoint (x)
|
|
bezier_wp_t::t_point_t | computeWwaypoints (const ProblemData &pData, double T) |
| computeConstantWaypoints compute the constant waypoints of w(t) defined by the constraints on initial and final states
|
|
coefs_t | computeFinalVelocityPoint (const ProblemData &pData, double T) |
|
int | dimVar (const ProblemData &pData) |
|
std::pair< MatrixXX, VectorX > | computeVelocityCost (const ProblemData &pData, double T, std::vector< bezier_t::point_t > pi) |
| computeVelocityCost the matrices H and g defining a cost that minimise the integral of the squared velocity
|
|
MatrixXX | initMatrixA (const int dimH, const std::vector< waypoint6_t > &wps, const long int extraConstraintSize, const bool useAngMomentum) |
|
MatrixXX | initMatrixD (const int colG, const std::vector< waypoint6_t > &wps, const long int extraConstraintSize, const bool useAngMomentum) |
|
void | addKinematic (Ref_matrixXX A, Ref_vectorX b, Cref_matrixX3 Kin, Cref_vectorX kin, const long int otherConstraintIndex) |
|
void | addAngularMomentum (Ref_matrixXX A, Ref_vectorX b, Cref_matrixX3 Ang, Cref_vectorX ang) |
|
int | removeZeroRows (Ref_matrixXX &A, Ref_vectorX &b) |
|
ResultData | solve (Cref_matrixXX A, Cref_vectorX ci0, Cref_matrixXX D, Cref_vectorX d, Cref_matrixXX H, Cref_vectorX g, Cref_vectorX initGuess, Cref_vectorX minBounds, Cref_vectorX maxBounds, const solvers::SolverType solver) |
|
ResultData | solve (Cref_matrixXX A, Cref_vectorX b, Cref_matrixXX H, Cref_vectorX g, Cref_vectorX initGuess, const solvers::SolverType solver) |
|
bezier_wp_t::t_point_t | computeDiscretizedWwaypoints (const ProblemData &pData, double T, const T_time &timeArray) |
|
std::pair< MatrixXX, VectorX > | dynamicStabilityConstraints_cross (const MatrixXX &mH, const VectorX &h, const Vector3 &g, const coefs_t &c, const coefs_t &ddc) |
|
std::pair< MatrixXX, VectorX > | dynamicStabilityConstraints (const MatrixXX &mH, const VectorX &h, const Vector3 &g, const waypoint_t &w) |
|
std::vector< int > | stepIdPerPhase (const T_time &timeArray) |
|
long int | computeNumIneq (const ProblemData &pData, const VectorX &Ts, const std::vector< int > &phaseSwitch) |
|
void | updateH (const ProblemData &pData, const ContactData &phase, MatrixXX &mH, VectorX &h, int &dimH) |
|
void | assignStabilityConstraintsForTimeStep (MatrixXX &mH, VectorX &h, const waypoint_t &wp_w, const int dimH, long int &id_rows, MatrixXX &A, VectorX &b, const Vector3 &g) |
|
void | assignStabilityConstraintsForTimeStepForce (const waypoint_t &wp_w, const long int rowIdx, long int &id_cols, const centroidal_dynamics::Matrix6X mG, MatrixXX &D, VectorX &d, const double mass, const Vector3 &g) |
|
void | switchContactPhase (const ProblemData &pData, MatrixXX &A, VectorX &b, MatrixXX &mH, VectorX &h, const waypoint_t &wp_w, const ContactData &phase, long int &id_rows, int &dimH) |
|
long int | assignStabilityConstraints (const ProblemData &pData, MatrixXX &A, VectorX &b, const T_time &timeArray, const double t_total, const std::vector< int > &stepIdForPhase) |
|
void | assignKinematicConstraints (const ProblemData &pData, MatrixXX &A, VectorX &b, const T_time &timeArray, const double t_total, const std::vector< int > &stepIdForPhase, long int &id_rows) |
|
void | assignAccelerationConstraints (const ProblemData &pData, MatrixXX &A, VectorX &b, const T_time &timeArray, const double t_total, long int &id_rows) |
|
std::pair< MatrixXX, VectorX > | computeConstraintsOneStep (const ProblemData &pData, const VectorX &Ts, const double t_total, const T_time &timeArray) |
|
void | computeFinalAcceleration (ResultDataCOMTraj &res) |
|
void | computeFinalVelocity (ResultDataCOMTraj &res) |
|
std::pair< MatrixXX, VectorX > | genCostFunction (const ProblemData &pData, const VectorX &Ts, const double T, const T_time &timeArray, const long int &dim) |
|
ResultDataCOMTraj | genTraj (ResultData resQp, const ProblemData &pData, const double T) |
|
long int | computeNumIneqContinuous (const ProblemData &pData, const VectorX &Ts, const int degree, const int w_degree, const bool useDD) |
| computeNumIneqContinuous compute the number of inequalitie required by all the phases
|
|
long int | computeNumEqContinuous (const ProblemData &pData, const int w_degree, const bool useForce, long int &forceVarDim) |
| computeNumEqContinuous compute the number of equalities required by all the phases
|
|
std::pair< MatrixXX, VectorX > | computeConstraintsContinuous (const ProblemData &pData, const VectorX &Ts, std::pair< MatrixXX, VectorX > &Dd, VectorX &minBounds, VectorX &) |
|
waypoint6_t | w0 (point_t_tC p0, point_t_tC p1, point_t_tC g, const Matrix3 &p0X, const Matrix3 &, const Matrix3 &, const double alpha) |
|
waypoint6_t | w1 (point_t_tC p0, point_t_tC p1, point_t_tC, const Matrix3 &, const Matrix3 &, const Matrix3 &gX, const double alpha) |
|
waypoint6_t | w2 (point_t_tC p0, point_t_tC p1, point_t_tC g, const Matrix3 &, const Matrix3 &, const Matrix3 &gX, const double alpha) |
|
waypoint6_t | w3 (point_t_tC p0, point_t_tC p1, point_t_tC g, const Matrix3 &, const Matrix3 &, const Matrix3 &, const double alpha) |
|
waypoint6_t | w4 (point_t_tC, point_t_tC p1, point_t_tC g, const Matrix3 &, const Matrix3 &, const Matrix3 &, const double alpha) |
|
waypoint6_t | u0 (point_t_tC l0, const double alpha) |
|
waypoint6_t | u1 (point_t_tC l0, const double alpha) |
|
waypoint6_t | u2 (point_t_tC l0, const double alpha) |
|
waypoint6_t | u3 (point_t_tC, const double alpha) |
|
waypoint6_t | u4 (point_t_tC, const double) |
|
int | computeNumSteps (const double T, const double timeStep) |
|
std::vector< waypoint6_t > | ComputeAllWaypoints (point_t_tC p0, point_t_tC dc0, point_t_tC g, const double T, const double timeStep) |
|
std::vector< waypoint6_t > | ComputeAllWaypointsAngularMomentum (point_t_tC l0, const double T, const double timeStep) |
|
std::pair< MatrixXX, VectorX > | compute6dControlPointInequalities (const ContactData &cData, point_t_tC c0, point_t_tC dc0, point_t_tC l0, const bool useAngMomentum, const double T, const double timeStep, bool &fail) |
|
std::pair< MatrixXX, VectorX > | computeCostFunction (point_t_tC p0, point_t_tC l0, const bool useAngMomentum) |
|
void | computeRealCost (const ProblemData &pData, ResultData &resData) |
|
void | computeC_of_T (const ProblemData &pData, const std::vector< double > &Ts, ResultDataCOMTraj &res) |
|
void | computedL_of_T (const ProblemData &pData, const std::vector< double > &Ts, ResultDataCOMTraj &res) |
|
template<> |
waypoint9_t | initwp< waypoint9_t > () |
|
template<> |
waypoint6_t | initwp< waypoint6_t > () |
|
template<> |
waypoint3_t | initwp< waypoint3_t > () |
|