ocra-recipes
Doxygen documentation for the ocra-recipes repository
Namespaces | Classes | Functions | Variables
ocra::utils Namespace Reference

Namespaces

 details
 

Classes

struct  add_functor
 
struct  assign_functor
 
struct  max_functor
 
struct  min_functor
 
struct  specialized_max
 
struct  specialized_max< double, double >
 
struct  specialized_min
 
struct  specialized_min< double, double >
 
struct  uncompress
 

Functions

int computeDimensionFor (ECartesianDof fixedPosition, ECartesianDof fixedOrientation)
 Computes the number of directions specified by two ECartesianDof enums. More...
 
int computeDimensionFor (ECartesianDof cDoF)
 
ECartesianDof cartesianDofFromString (const std::string &dofString)
 
std::string cartesianDofToString (const ECartesianDof dofEnum)
 
Eigen::Matrix< double, 6, 1 > cartesianPDCoupling (const Eigen::Matrix< double, 6, 1 > &kp, const Eigen::Displacementd &Hdes, const Eigen::Displacementd &H, const Eigen::Matrix< double, 6, 1 > &kv, const Eigen::Twistd &Tdes, const Eigen::Twistd &T)
 
Eigen::Matrix< double, 6, 1 > cartesianPCoupling (const Eigen::Matrix< double, 6, 1 > &kp, const Eigen::Displacementd &Hdes, const Eigen::Displacementd &H)
 
Eigen::Matrix< double, 6, 1 > cartesianDCoupling (const Eigen::Matrix< double, 6, 1 > &kv, const Eigen::Twistd &Tdes, const Eigen::Twistd &T)
 
Eigen::VectorXd adaptKToInertia (const Eigen::VectorXd &K, const Model &model, double scale=1.)
 
Eigen::Displacementd compute_H_2_in_1 (const Eigen::Displacementd &H_1_in_ref, const Eigen::Displacementd &H_2_in_ref)
 
Eigen::Displacementd computeEgoFrame (Model &model, const Eigen::Vector3d &fwdDirection_in_phantom)
 
Eigen::Displacementd interpolate (const Eigen::Displacementd &Hstart, const Eigen::Displacementd &Hend, double t)
 
Eigen::Displacementd projectRotation (const Eigen::Displacementd &H, const Eigen::Vector3d &n, double &theta)
 
int getAddType (const Function &f1, const Function &f2)
 
int getAddContinuityProperty (const Function &f1, const Function &f2)
 
bool computeGradient (const Function &f1, const Function &f2)
 
bool computeHessian (const Function &f1, const Function &f2)
 
int getOppositeConvexityProperty (const Function &f)
 
VariablecreateOutputVariable (Function &f)
 
template<class Derived , class VectorBase >
void printLinearEquation (const MatrixBase< Derived > &A, const VectorBase &b, int space=9, int precision=3)
 
void printSolution (const VectorXd &result, const Variable &var, int space=9, int precision=3)
 
template<class Derived , class VectorBase1 , class VectorBase2 >
void convert (const LinearConstraint &cstr, const std::vector< int > &mapping, eConstraintOutput type, MatrixBase< Derived > &A, VectorBase1 &b, VectorBase2 &l, double infinity=0.)
 
template<class VectorBase1 , class VectorBase2 >
void intersectBounds (const DiagonalLinearConstraint &bounds, const std::vector< int > &mapping, VectorBase1 &bl, VectorBase2 &bu)
 
template<class Derived1 , class Derived2 >
void uncompressByCol (const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &_out, const std::vector< int > &mapping, double scale, bool reverseMapping)
 
template<class Derived1 , class Derived2 >
void uncompressByCol (const Variable &base, const Variable &rel, const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &_out, std::vector< int > &mapping, double scale)
 
template<class Derived1 , class Derived2 >
void uncompressByRow (const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &_out, const std::vector< int > &mapping, double scale, bool reverseMapping)
 
template<class Derived1 , class Derived2 >
void uncompressByRow (const Variable &base, const Variable &rel, const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &out, std::vector< int > &mapping, double scale)
 
template<class Derived1 , class Derived2 >
void uncompress2d (const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &_out, const std::vector< int > &mapping, double scale, bool reverseMapping)
 
template<class Derived1 , class Derived2 >
void uncompress2d (const Variable &base, const Variable &rel, const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &out, std::vector< int > &mapping, double scale)
 
template<class Derived1 , class Derived2 >
void addCompressedByCol (const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &_out, const std::vector< int > &mapping, double scale, bool reverseMapping)
 
template<class Derived1 , class Derived2 >
void addCompressedByCol (const Variable &base, const Variable &rel, const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &out, std::vector< int > &mapping, double scale)
 
template<class Derived1 , class Derived2 >
void addCompressedByRow (const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &_out, const std::vector< int > &mapping, double scale, bool reverseMapping)
 
template<class Derived1 , class Derived2 >
void addCompressedByRow (const Variable &base, const Variable &rel, const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &out, std::vector< int > &mapping, double scale)
 
template<class Derived1 , class Derived2 >
void addCompressed2d (const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &_out, const std::vector< int > &mapping, double scale, bool reverseMapping)
 
template<class Derived1 , class Derived2 >
void addCompressed2d (const Variable &base, const Variable &rel, const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &_out, std::vector< int > &mapping, double scale)
 
template<class Derived1 , class Derived2 >
void minCompressedByCol (const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &_out, const std::vector< int > &mapping, double scale, bool reverseMapping)
 
template<class Derived1 , class Derived2 >
void minCompressedByCol (const Variable &base, const Variable &rel, const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &out, std::vector< int > &mapping, double scale)
 
template<class Derived1 , class Derived2 >
void minCompressedByRow (const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &_out, const std::vector< int > &mapping, double scale, bool reverseMapping)
 
template<class Derived1 , class Derived2 >
void minCompressedByRow (const Variable &base, const Variable &rel, const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &out, std::vector< int > &mapping, double scale)
 
template<class Derived1 , class Derived2 >
void minCompressed2d (const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &_out, const std::vector< int > &mapping, double scale, bool reverseMapping)
 
template<class Derived1 , class Derived2 >
void minCompressed2d (const Variable &base, const Variable &rel, const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &out, std::vector< int > &mapping, double scale)
 
template<class Derived1 , class Derived2 >
void maxCompressedByCol (const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &_out, const std::vector< int > &mapping, double scale, bool reverseMapping)
 
template<class Derived1 , class Derived2 >
void maxCompressedByCol (const Variable &base, const Variable &rel, const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &out, std::vector< int > &mapping, double scale)
 
template<class Derived1 , class Derived2 >
void maxCompressedByRow (const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &_out, const std::vector< int > &mapping, double scale, bool reverseMapping)
 
template<class Derived1 , class Derived2 >
void maxCompressedByRow (const Variable &base, const Variable &rel, const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &out, std::vector< int > &mapping, double scale)
 
template<class Derived1 , class Derived2 >
void maxCompressed2d (const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &_out, const std::vector< int > &mapping, double scale, bool reverseMapping)
 
template<class Derived1 , class Derived2 >
void maxCompressed2d (const Variable &base, const Variable &rel, const MatrixBase< Derived1 > &in, MatrixBase< Derived2 > const &out, std::vector< int > &mapping, double scale)
 
template<class Derived >
void writeInFile (const MatrixBase< Derived > &m, const std::string &fileName, bool app=false)
 
template<class Derived >
std::ostream & writeInFile (std::ostream &s, const MatrixBase< Derived > &m, int precision=-1, const std::string &coeffSeparator=" ", const std::string &rowSeparator="\n", const std::string &rowPrefix="", const std::string &rowSuffix="", const std::string &matPrefix="", const std::string &matSuffix="")
 
template<class Derived >
std::ostream & writeInFile (std::ostream &s, const MatrixBase< Derived > &v, int precision=-1, const std::string &coeffSeparator=" ", const std::string &vectPrefix="", const std::string &vectSuffix="")
 
template<class Derived >
std::ostream & writeInFileForScilab (std::ostream &s, const MatrixBase< Derived > &m, int precision=-1)
 
VectorXd adaptKToInertia (const VectorXd &K, const Model &model, double scale)
 
Eigen::Displacementd computeEgoFrame (Model &model, const Vector3d &fwdDirection_in_phantom)
 
Eigen::Displacementd projectRotation (const Eigen::Displacementd &H, const Vector3d &n, double &theta)
 

Variables

const details::eConvertCase conversion_cases [7][7]
 

Function Documentation

VectorXd ocra::utils::adaptKToInertia ( const VectorXd &  K,
const Model model,
double  scale 
)

Definition at line 29 of file controlUtils.cpp.

Eigen::VectorXd ocra::utils::adaptKToInertia ( const Eigen::VectorXd &  K,
const Model model,
double  scale = 1. 
)

Multiply a vector of gains by the diagonal of an inertia matrix and a scale.

Returns
v, where v(i) = K(i) * model.getInertiaMatrix()(i, i) * scale.
template<class Derived1 , class Derived2 >
void ocra::utils::addCompressed2d ( const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  _out,
const std::vector< int > &  mapping,
double  scale,
bool  reverseMapping 
)
inline

Definition at line 226 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::addCompressed2d ( const Variable base,
const Variable rel,
const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  _out,
std::vector< int > &  mapping,
double  scale 
)
inline

Definition at line 237 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::addCompressedByCol ( const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  _out,
const std::vector< int > &  mapping,
double  scale,
bool  reverseMapping 
)
inline

Definition at line 172 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::addCompressedByCol ( const Variable base,
const Variable rel,
const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  out,
std::vector< int > &  mapping,
double  scale 
)
inline

Definition at line 183 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::addCompressedByRow ( const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  _out,
const std::vector< int > &  mapping,
double  scale,
bool  reverseMapping 
)
inline

Definition at line 199 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::addCompressedByRow ( const Variable base,
const Variable rel,
const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  out,
std::vector< int > &  mapping,
double  scale 
)
inline

Definition at line 210 of file SolverUtilities.hxx.

Vector6d ocra::utils::cartesianDCoupling ( const Eigen::Matrix< double, 6, 1 > &  kv,
const Eigen::Twistd &  Tdes,
const Eigen::Twistd &  T 
)

Compute kv * T where T = Tdes-T where p = pdes - p and r = log(Rdes^T*R)

Definition at line 17 of file controlUtils.cpp.

ECartesianDof ocra::utils::cartesianDofFromString ( const std::string &  dofString)
inline

Definition at line 58 of file ControlEnum.h.

std::string ocra::utils::cartesianDofToString ( const ECartesianDof  dofEnum)
inline

Definition at line 75 of file ControlEnum.h.

Vector6d ocra::utils::cartesianPCoupling ( const Eigen::Matrix< double, 6, 1 > &  kp,
const Eigen::Displacementd &  Hdes,
const Eigen::Displacementd &  H 
)

Compute kp* H where H = ( p r)^T where p = pdes - p and r = log(Rdes^T*R)

Definition at line 7 of file controlUtils.cpp.

Vector6d ocra::utils::cartesianPDCoupling ( const Eigen::Matrix< double, 6, 1 > &  kp,
const Eigen::Displacementd &  Hdes,
const Eigen::Displacementd &  H,
const Eigen::Matrix< double, 6, 1 > &  kv,
const Eigen::Twistd &  Tdes,
const Eigen::Twistd &  T 
)

Compute kp* H + kv * T where H = ( p r)^T and T = Tdes-T where p = pdes - p and r = log(Rdes^T*R)

Definition at line 23 of file controlUtils.cpp.

Eigen::Displacementd ocra::utils::compute_H_2_in_1 ( const Eigen::Displacementd &  H_1_in_ref,
const Eigen::Displacementd &  H_2_in_ref 
)
Warning
This function is deprecated. This function is useful in scripts where Displacements were not completely bound. In such contexts, you cannot write H1.inverse() * H2, so this function can do it for you. [TODO] Remove this function.

Definition at line 40 of file controlUtils.cpp.

int ocra::utils::computeDimensionFor ( ECartesianDof  fixedPosition,
ECartesianDof  fixedOrientation 
)
inline

Computes the number of directions specified by two ECartesianDof enums.

Examples: computeDimensionFor(NONE, NONE) == 0 computeDimensionFor(XY, XYZ) == 5 computeDimensionFor(Z, NONE) == 1

Definition at line 39 of file ControlEnum.h.

int ocra::utils::computeDimensionFor ( ECartesianDof  cDoF)
inline

Definition at line 45 of file ControlEnum.h.

Eigen::Displacementd ocra::utils::computeEgoFrame ( Model model,
const Vector3d &  fwdDirection_in_phantom 
)

Definition at line 45 of file controlUtils.cpp.

Eigen::Displacementd ocra::utils::computeEgoFrame ( Model model,
const Eigen::Vector3d &  fwdDirection_in_phantom 
)

Computes the displacement of an ego frame wrt the world frame for a manikin. The ego frame is built as follows: the x direction is defined by the user, by giving its coordinates in the root frame of the robot; this vector is supposed to represent the 'forward' direction of the manikin. the z direction is the world frame z; y = z cross x.

bool ocra::utils::computeGradient ( const Function f1,
const Function f2 
)

Definition at line 53 of file FunctionUtilities.cpp.

bool ocra::utils::computeHessian ( const Function f1,
const Function f2 
)

Definition at line 58 of file FunctionUtilities.cpp.

template<class Derived , class VectorBase1 , class VectorBase2 >
void ocra::utils::convert ( const LinearConstraint cstr,
const std::vector< int > &  mapping,
eConstraintOutput  type,
MatrixBase< Derived > &  A,
VectorBase1 &  b,
VectorBase2 &  l,
double  infinity = 0. 
)
inline

Definition at line 478 of file SolverUtilities.hxx.

Variable * ocra::utils::createOutputVariable ( Function f)

Definition at line 115 of file FunctionUtilities.cpp.

int ocra::utils::getAddContinuityProperty ( const Function f1,
const Function f2 
)

Definition at line 48 of file FunctionUtilities.cpp.

int ocra::utils::getAddType ( const Function f1,
const Function f2 
)

Definition at line 10 of file FunctionUtilities.cpp.

int ocra::utils::getOppositeConvexityProperty ( const Function f)

Definition at line 75 of file FunctionUtilities.cpp.

Eigen::Displacementd ocra::utils::interpolate ( const Eigen::Displacementd &  Hstart,
const Eigen::Displacementd &  Hend,
double  t 
)

Spline interpolator.

Definition at line 56 of file controlUtils.cpp.

template<class VectorBase1 , class VectorBase2 >
void ocra::utils::intersectBounds ( const DiagonalLinearConstraint bounds,
const std::vector< int > &  mapping,
VectorBase1 &  bl,
VectorBase2 &  bu 
)
inline

Intersects the set described by bounds with the one already described by bl and bu and put the result into bl and bu. bounds must be either a IdentityConstraint or a BoundConstraint

Definition at line 556 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::maxCompressed2d ( const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  _out,
const std::vector< int > &  mapping,
double  scale,
bool  reverseMapping 
)
inline

Definition at line 398 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::maxCompressed2d ( const Variable base,
const Variable rel,
const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  out,
std::vector< int > &  mapping,
double  scale 
)
inline

Definition at line 409 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::maxCompressedByCol ( const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  _out,
const std::vector< int > &  mapping,
double  scale,
bool  reverseMapping 
)
inline

Definition at line 344 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::maxCompressedByCol ( const Variable base,
const Variable rel,
const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  out,
std::vector< int > &  mapping,
double  scale 
)
inline

Definition at line 355 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::maxCompressedByRow ( const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  _out,
const std::vector< int > &  mapping,
double  scale,
bool  reverseMapping 
)
inline

Definition at line 371 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::maxCompressedByRow ( const Variable base,
const Variable rel,
const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  out,
std::vector< int > &  mapping,
double  scale 
)
inline

Definition at line 382 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::minCompressed2d ( const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  _out,
const std::vector< int > &  mapping,
double  scale,
bool  reverseMapping 
)
inline

Definition at line 313 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::minCompressed2d ( const Variable base,
const Variable rel,
const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  out,
std::vector< int > &  mapping,
double  scale 
)
inline

Definition at line 324 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::minCompressedByCol ( const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  _out,
const std::vector< int > &  mapping,
double  scale,
bool  reverseMapping 
)
inline

Definition at line 259 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::minCompressedByCol ( const Variable base,
const Variable rel,
const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  out,
std::vector< int > &  mapping,
double  scale 
)
inline

Definition at line 270 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::minCompressedByRow ( const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  _out,
const std::vector< int > &  mapping,
double  scale,
bool  reverseMapping 
)
inline

Definition at line 286 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::minCompressedByRow ( const Variable base,
const Variable rel,
const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  out,
std::vector< int > &  mapping,
double  scale 
)
inline

Definition at line 297 of file SolverUtilities.hxx.

template<class Derived , class VectorBase >
void ocra::utils::printLinearEquation ( const MatrixBase< Derived > &  A,
const VectorBase &  b,
int  space = 9,
int  precision = 3 
)
inline

Print in a formated way the coefficient of a linear equation described by A and b

Definition at line 13 of file SolverUtilities.hxx.

void ocra::utils::printSolution ( const VectorXd &  result,
const Variable var,
int  space = 9,
int  precision = 3 
)

Print the solution stored in result according to the form of the variable var

Definition at line 39 of file SolverUtilities.cpp.

Eigen::Displacementd ocra::utils::projectRotation ( const Eigen::Displacementd &  H,
const Eigen::Vector3d &  n,
double &  theta 
)

project the rotation R: Rp = I + sin(theta)[n] + (1-cos(theta))[n]^2 = sin(theta)[n] + (1-cos(theta))nn^t + cos(theta)*I theta minimize -tr(R^t*Rp)

Eigen::Displacementd ocra::utils::projectRotation ( const Eigen::Displacementd &  H,
const Vector3d &  n,
double &  theta 
)

Definition at line 79 of file controlUtils.cpp.

template<class Derived1 , class Derived2 >
void ocra::utils::uncompress2d ( const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  _out,
const std::vector< int > &  mapping,
double  scale,
bool  reverseMapping 
)
inline

Definition at line 140 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::uncompress2d ( const Variable base,
const Variable rel,
const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  out,
std::vector< int > &  mapping,
double  scale 
)
inline

Definition at line 151 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::uncompressByCol ( const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  _out,
const std::vector< int > &  mapping,
double  scale,
bool  reverseMapping 
)
inline

Definition at line 83 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::uncompressByCol ( const Variable base,
const Variable rel,
const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  _out,
std::vector< int > &  mapping,
double  scale 
)
inline

Definition at line 96 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::uncompressByRow ( const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  _out,
const std::vector< int > &  mapping,
double  scale,
bool  reverseMapping 
)
inline

Definition at line 113 of file SolverUtilities.hxx.

template<class Derived1 , class Derived2 >
void ocra::utils::uncompressByRow ( const Variable base,
const Variable rel,
const MatrixBase< Derived1 > &  in,
MatrixBase< Derived2 > const &  out,
std::vector< int > &  mapping,
double  scale 
)
inline

Definition at line 124 of file SolverUtilities.hxx.

template<class Derived >
void ocra::utils::writeInFile ( const MatrixBase< Derived > &  m,
const std::string &  fileName,
bool  app = false 
)
inline

Definition at line 27 of file FileOperations.h.

template<class Derived >
std::ostream& ocra::utils::writeInFile ( std::ostream &  s,
const MatrixBase< Derived > &  m,
int  precision = -1,
const std::string &  coeffSeparator = " ",
const std::string &  rowSeparator = "\n",
const std::string &  rowPrefix = "",
const std::string &  rowSuffix = "",
const std::string &  matPrefix = "",
const std::string &  matSuffix = "" 
)
inline

Definition at line 50 of file FileOperations.h.

template<class Derived >
std::ostream& ocra::utils::writeInFile ( std::ostream &  s,
const MatrixBase< Derived > &  v,
int  precision = -1,
const std::string &  coeffSeparator = " ",
const std::string &  vectPrefix = "",
const std::string &  vectSuffix = "" 
)
inline

Overload for a vector

Definition at line 88 of file FileOperations.h.

template<class Derived >
std::ostream& ocra::utils::writeInFileForScilab ( std::ostream &  s,
const MatrixBase< Derived > &  m,
int  precision = -1 
)
inline

Definition at line 107 of file FileOperations.h.

Variable Documentation

const eConvertCase ocra::utils::conversion_cases
Initial value:
= {
}

Definition at line 27 of file SolverUtilities.cpp.