Salome HOME
Implementation of planar symmetry + aggregation methods for MEDFileData+MEDFileUMesh
[tools/medcoupling.git] / src / MEDCoupling / MEDCouplingMemArray.cxx
index 28806d19d08a755c9ca918e3c3d427940c22decf..194cdccf4dc382df760b3f55f1ce0ce6e3c0fabb 100644 (file)
@@ -19,7 +19,6 @@
 // Author : Anthony Geay (CEA/DEN)
 
 #include "MEDCouplingMemArray.txx"
-#include "MCAuto.hxx"
 
 #include "BBTree.txx"
 #include "GenMathFormulae.hxx"
@@ -37,6 +36,9 @@ typedef double (*MYFUNCPTR)(double);
 
 using namespace MEDCoupling;
 
+template class DataArrayTemplate<int>;
+template class DataArrayTemplate<double>;
+
 template<int SPACEDIM>
 void DataArrayDouble::findCommonTuplesAlg(const double *bbox, int nbNodes, int limitNodeId, double prec, DataArrayInt *c, DataArrayInt *cI) const
 {
@@ -750,43 +752,6 @@ DataArrayDouble *DataArrayDouble::New()
   return new DataArrayDouble;
 }
 
-/*!
- * Checks if raw data is allocated. Read more on the raw data
- * in \ref MEDCouplingArrayBasicsTuplesAndCompo "DataArrays infos" for more information.
- *  \return bool - \a true if the raw data is allocated, \a false else.
- */
-bool DataArrayDouble::isAllocated() const
-{
-  return getConstPointer()!=0;
-}
-
-/*!
- * Checks if raw data is allocated and throws an exception if it is not the case.
- *  \throw If the raw data is not allocated.
- */
-void DataArrayDouble::checkAllocated() const
-{
-  if(!isAllocated())
-    throw INTERP_KERNEL::Exception("DataArrayDouble::checkAllocated : Array is defined but not allocated ! Call alloc or setValues method first !");
-}
-
-/*!
- * This method desallocated \a this without modification of informations relative to the components.
- * After call of this method, DataArrayDouble::isAllocated will return false.
- * If \a this is already not allocated, \a this is let unchanged.
- */
-void DataArrayDouble::desallocate()
-{
-  _mem.destroy();
-}
-
-std::size_t DataArrayDouble::getHeapMemorySizeWithoutChildren() const
-{
-  std::size_t sz(_mem.getNbOfElemAllocated());
-  sz*=sizeof(double);
-  return DataArray::getHeapMemorySizeWithoutChildren()+sz;
-}
-
 /*!
  * Returns the only one value in \a this, if and only if number of elements
  * (nb of tuples * nb of components) is equal to 1, and that \a this is allocated.
@@ -808,17 +773,6 @@ double DataArrayDouble::doubleValue() const
     throw INTERP_KERNEL::Exception("DataArrayDouble::doubleValue : DataArrayDouble instance is not allocated !");
 }
 
-/*!
- * Checks the number of tuples.
- *  \return bool - \a true if getNumberOfTuples() == 0, \a false else.
- *  \throw If \a this is not allocated.
- */
-bool DataArrayDouble::empty() const
-{
-  checkAllocated();
-  return getNumberOfTuples()==0;
-}
-
 /*!
  * Returns a full copy of \a this. For more info on copying data arrays see
  * \ref MEDCouplingArrayBasicsCopyDeep.
@@ -848,154 +802,6 @@ DataArrayDouble *DataArrayDouble::performCopyOrIncrRef(bool dCpy) const
     }
 }
 
-/*!
- * Copies all the data from another DataArrayDouble. For more info see
- * \ref MEDCouplingArrayBasicsCopyDeepAssign.
- *  \param [in] other - another instance of DataArrayDouble to copy data from.
- *  \throw If the \a other is not allocated.
- */
-void DataArrayDouble::deepCopyFrom(const DataArrayDouble& other)
-{
-  other.checkAllocated();
-  int nbOfTuples=other.getNumberOfTuples();
-  int nbOfComp=other.getNumberOfComponents();
-  allocIfNecessary(nbOfTuples,nbOfComp);
-  std::size_t nbOfElems=(std::size_t)nbOfTuples*nbOfComp;
-  double *pt=getPointer();
-  const double *ptI=other.getConstPointer();
-  for(std::size_t i=0;i<nbOfElems;i++)
-    pt[i]=ptI[i];
-  copyStringInfoFrom(other);
-}
-
-/*!
- * This method reserve nbOfElems elements in memory ( nbOfElems*8 bytes ) \b without impacting the number of tuples in \a this.
- * If \a this has already been allocated, this method checks that \a this has only one component. If not an INTERP_KERNEL::Exception will be thrown.
- * If \a this has not already been allocated, number of components is set to one.
- * This method allows to reduce number of reallocations on invokation of DataArrayDouble::pushBackSilent and DataArrayDouble::pushBackValsSilent on \a this.
- * 
- * \sa DataArrayDouble::pack, DataArrayDouble::pushBackSilent, DataArrayDouble::pushBackValsSilent
- */
-void DataArrayDouble::reserve(std::size_t nbOfElems)
-{
-  int nbCompo=getNumberOfComponents();
-  if(nbCompo==1)
-    {
-      _mem.reserve(nbOfElems);
-    }
-  else if(nbCompo==0)
-    {
-      _mem.reserve(nbOfElems);
-      _info_on_compo.resize(1);
-    }
-  else
-    throw INTERP_KERNEL::Exception("DataArrayDouble::reserve : not available for DataArrayDouble with number of components different than 1 !");
-}
-
-/*!
- * This method adds at the end of \a this the single value \a val. This method do \b not update its time label to avoid useless incrementation
- * of counter. So the caller is expected to call TimeLabel::declareAsNew on \a this at the end of the push session.
- *
- * \param [in] val the value to be added in \a this
- * \throw If \a this has already been allocated with number of components different from one.
- * \sa DataArrayDouble::pushBackValsSilent
- */
-void DataArrayDouble::pushBackSilent(double val)
-{
-  int nbCompo=getNumberOfComponents();
-  if(nbCompo==1)
-    _mem.pushBack(val);
-  else if(nbCompo==0)
-    {
-      _info_on_compo.resize(1);
-      _mem.pushBack(val);
-    }
-  else
-    throw INTERP_KERNEL::Exception("DataArrayDouble::pushBackSilent : not available for DataArrayDouble with number of components different than 1 !");
-}
-
-/*!
- * This method adds at the end of \a this a serie of values [\c valsBg,\c valsEnd). This method do \b not update its time label to avoid useless incrementation
- * of counter. So the caller is expected to call TimeLabel::declareAsNew on \a this at the end of the push session.
- *
- *  \param [in] valsBg - an array of values to push at the end of \c this.
- *  \param [in] valsEnd - specifies the end of the array \a valsBg, so that
- *              the last value of \a valsBg is \a valsEnd[ -1 ].
- * \throw If \a this has already been allocated with number of components different from one.
- * \sa DataArrayDouble::pushBackSilent
- */
-void DataArrayDouble::pushBackValsSilent(const double *valsBg, const double *valsEnd)
-{
-  int nbCompo=getNumberOfComponents();
-  if(nbCompo==1)
-    _mem.insertAtTheEnd(valsBg,valsEnd);
-  else if(nbCompo==0)
-    {
-      _info_on_compo.resize(1);
-      _mem.insertAtTheEnd(valsBg,valsEnd);
-    }
-  else
-    throw INTERP_KERNEL::Exception("DataArrayDouble::pushBackValsSilent : not available for DataArrayDouble with number of components different than 1 !");
-}
-
-/*!
- * This method returns silently ( without updating time label in \a this ) the last value, if any and suppress it.
- * \throw If \a this is already empty.
- * \throw If \a this has number of components different from one.
- */
-double DataArrayDouble::popBackSilent()
-{
-  if(getNumberOfComponents()==1)
-    return _mem.popBack();
-  else
-    throw INTERP_KERNEL::Exception("DataArrayDouble::popBackSilent : not available for DataArrayDouble with number of components different than 1 !");
-}
-
-/*!
- * This method \b do \b not modify content of \a this. It only modify its memory footprint if the allocated memory is to high regarding real data to store.
- *
- * \sa DataArrayDouble::getHeapMemorySizeWithoutChildren, DataArrayDouble::reserve
- */
-void DataArrayDouble::pack() const
-{
-  _mem.pack();
-}
-
-/*!
- * Allocates the raw data in memory. If exactly same memory as needed already
- * allocated, it is not re-allocated.
- *  \param [in] nbOfTuple - number of tuples of data to allocate.
- *  \param [in] nbOfCompo - number of components of data to allocate.
- *  \throw If \a nbOfTuple < 0 or \a nbOfCompo < 0.
- */
-void DataArrayDouble::allocIfNecessary(int nbOfTuple, int nbOfCompo)
-{
-  if(isAllocated())
-    {
-      if(nbOfTuple!=getNumberOfTuples() || nbOfCompo!=getNumberOfComponents())
-        alloc(nbOfTuple,nbOfCompo);
-    }
-  else
-    alloc(nbOfTuple,nbOfCompo);
-}
-
-/*!
- * Allocates the raw data in memory. If the memory was already allocated, then it is
- * freed and re-allocated. See an example of this method use
- * \ref MEDCouplingArraySteps1WC "here".
- *  \param [in] nbOfTuple - number of tuples of data to allocate.
- *  \param [in] nbOfCompo - number of components of data to allocate.
- *  \throw If \a nbOfTuple < 0 or \a nbOfCompo < 0.
- */
-void DataArrayDouble::alloc(int nbOfTuple, int nbOfCompo)
-{
-  if(nbOfTuple<0 || nbOfCompo<0)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::alloc : request for negative length of data !");
-  _info_on_compo.resize(nbOfCompo);
-  _mem.alloc(nbOfCompo*(std::size_t)nbOfTuple);
-  declareAsNew();
-}
-
 /*!
  * Assign zero to all values in \a this array. To know more on filling arrays see
  * \ref MEDCouplingArrayFill.
@@ -1003,22 +809,7 @@ void DataArrayDouble::alloc(int nbOfTuple, int nbOfCompo)
  */
 void DataArrayDouble::fillWithZero()
 {
-  checkAllocated();
-  _mem.fillWithValue(0.);
-  declareAsNew();
-}
-
-/*!
- * Assign \a val to all values in \a this array. To know more on filling arrays see
- * \ref MEDCouplingArrayFill.
- *  \param [in] val - the value to fill with.
- *  \throw If \a this is not allocated.
- */
-void DataArrayDouble::fillWithValue(double val)
-{
-  checkAllocated();
-  _mem.fillWithValue(val);
-  declareAsNew();
+  fillWithValue(0.);
 }
 
 /*!
@@ -1065,33 +856,6 @@ bool DataArrayDouble::isUniform(double val, double eps) const
   return true;
 }
 
-/*!
- * Sorts values of the array.
- *  \param [in] asc - \a true means ascending order, \a false, descending.
- *  \throw If \a this is not allocated.
- *  \throw If \a this->getNumberOfComponents() != 1.
- */
-void DataArrayDouble::sort(bool asc)
-{
-  checkAllocated();
-  if(getNumberOfComponents()!=1)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::sort : only supported with 'this' array with ONE component !");
-  _mem.sort(asc);
-  declareAsNew();
-}
-
-/*!
- * Reverse the array values.
- *  \throw If \a this->getNumberOfComponents() < 1.
- *  \throw If \a this is not allocated.
- */
-void DataArrayDouble::reverse()
-{
-  checkAllocated();
-  _mem.reverse(getNumberOfComponents());
-  declareAsNew();
-}
-
 /*!
  * Checks that \a this array is consistently **increasing** or **decreasing** in value,
  * with at least absolute difference value of |\a eps| at each step.
@@ -1386,22 +1150,6 @@ bool DataArrayDouble::isEqualWithoutConsideringStr(const DataArrayDouble& other,
   return _mem.isEqual(other._mem,prec,tmp);
 }
 
-/*!
- * Changes number of tuples in the array. If the new number of tuples is smaller
- * than the current number the array is truncated, otherwise the array is extended.
- *  \param [in] nbOfTuples - new number of tuples. 
- *  \throw If \a this is not allocated.
- *  \throw If \a nbOfTuples is negative.
- */
-void DataArrayDouble::reAlloc(int nbOfTuples)
-{
-  if(nbOfTuples<0)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::reAlloc : input new number of tuples should be >=0 !");
-  checkAllocated();
-  _mem.reAlloc(getNumberOfComponents()*(std::size_t)nbOfTuples);
-  declareAsNew();
-}
-
 /*!
  * Creates a new DataArrayInt and assigns all (textual and numerical) data of \a this
  * array to the new one.
@@ -1460,592 +1208,110 @@ DataArrayDouble *DataArrayDouble::toNoInterlace() const
 }
 
 /*!
- * Permutes values of \a this array as required by \a old2New array. The values are
- * permuted so that \c new[ \a old2New[ i ]] = \c old[ i ]. Number of tuples remains
- * the same as in \c this one.
- * If a permutation reduction is needed, subArray() or selectByTupleId() should be used.
- * For more info on renumbering see \ref numbering.
- *  \param [in] old2New - C array of length equal to \a this->getNumberOfTuples()
- *     giving a new position for i-th old value.
+ * Appends components of another array to components of \a this one, tuple by tuple.
+ * So that the number of tuples of \a this array remains the same and the number of 
+ * components increases.
+ *  \param [in] other - the DataArrayDouble to append to \a this one.
+ *  \throw If \a this is not allocated.
+ *  \throw If \a this and \a other arrays have different number of tuples.
+ *
+ *  \if ENABLE_EXAMPLES
+ *  \ref cpp_mcdataarraydouble_meldwith "Here is a C++ example".
+ *
+ *  \ref py_mcdataarraydouble_meldwith "Here is a Python example".
+ *  \endif
  */
-void DataArrayDouble::renumberInPlace(const int *old2New)
+void DataArrayDouble::meldWith(const DataArrayDouble *other)
 {
   checkAllocated();
-  int nbTuples=getNumberOfTuples();
-  int nbOfCompo=getNumberOfComponents();
-  double *tmp=new double[nbTuples*nbOfCompo];
-  const double *iptr=getConstPointer();
-  for(int i=0;i<nbTuples;i++)
+  other->checkAllocated();
+  int nbOfTuples=getNumberOfTuples();
+  if(nbOfTuples!=other->getNumberOfTuples())
+    throw INTERP_KERNEL::Exception("DataArrayDouble::meldWith : mismatch of number of tuples !");
+  int nbOfComp1=getNumberOfComponents();
+  int nbOfComp2=other->getNumberOfComponents();
+  double *newArr=(double *)malloc((nbOfTuples*(nbOfComp1+nbOfComp2))*sizeof(double));
+  double *w=newArr;
+  const double *inp1=getConstPointer();
+  const double *inp2=other->getConstPointer();
+  for(int i=0;i<nbOfTuples;i++,inp1+=nbOfComp1,inp2+=nbOfComp2)
     {
-      int v=old2New[i];
-      if(v>=0 && v<nbTuples)
-        std::copy(iptr+nbOfCompo*i,iptr+nbOfCompo*(i+1),tmp+nbOfCompo*v);
-      else
-        {
-          std::ostringstream oss; oss << "DataArrayDouble::renumberInPlace : At place #" << i << " value is " << v << " ! Should be in [0," << nbTuples << ") !";
-          throw INTERP_KERNEL::Exception(oss.str().c_str());
-        }
+      w=std::copy(inp1,inp1+nbOfComp1,w);
+      w=std::copy(inp2,inp2+nbOfComp2,w);
     }
-  std::copy(tmp,tmp+nbTuples*nbOfCompo,getPointer());
-  delete [] tmp;
-  declareAsNew();
+  useArray(newArr,true,C_DEALLOC,nbOfTuples,nbOfComp1+nbOfComp2);
+  std::vector<int> compIds(nbOfComp2);
+  for(int i=0;i<nbOfComp2;i++)
+    compIds[i]=nbOfComp1+i;
+  copyPartOfStringInfoFrom2(compIds,*other);
 }
 
 /*!
- * Permutes values of \a this array as required by \a new2Old array. The values are
- * permuted so that \c new[ i ] = \c old[ \a new2Old[ i ]]. Number of tuples remains
- * the same as in \c this one.
- * For more info on renumbering see \ref numbering.
- *  \param [in] new2Old - C array of length equal to \a this->getNumberOfTuples()
- *     giving a previous position of i-th new value.
- *  \return DataArrayDouble * - the new instance of DataArrayDouble that the caller
- *          is to delete using decrRef() as it is no more needed.
+ * This method checks that all tuples in \a other are in \a this.
+ * If true, the output param \a tupleIds contains the tuples ids of \a this that correspond to tupes in \a this.
+ * For each i in [ 0 , other->getNumberOfTuples() ) tuple #i in \a other is equal ( regarding input precision \a prec ) to tuple tupleIds[i] in \a this.
+ *
+ * \param [in] other - the array having the same number of components than \a this.
+ * \param [out] tupleIds - the tuple ids containing the same number of tuples than \a other has.
+ * \sa DataArrayDouble::findCommonTuples
  */
-void DataArrayDouble::renumberInPlaceR(const int *new2Old)
+bool DataArrayDouble::areIncludedInMe(const DataArrayDouble *other, double prec, DataArrayInt *&tupleIds) const
 {
-  checkAllocated();
-  int nbTuples=getNumberOfTuples();
-  int nbOfCompo=getNumberOfComponents();
-  double *tmp=new double[nbTuples*nbOfCompo];
-  const double *iptr=getConstPointer();
-  for(int i=0;i<nbTuples;i++)
-    {
-      int v=new2Old[i];
-      if(v>=0 && v<nbTuples)
-        std::copy(iptr+nbOfCompo*v,iptr+nbOfCompo*(v+1),tmp+nbOfCompo*i);
-      else
-        {
-          std::ostringstream oss; oss << "DataArrayDouble::renumberInPlaceR : At place #" << i << " value is " << v << " ! Should be in [0," << nbTuples << ") !";
-          throw INTERP_KERNEL::Exception(oss.str().c_str());
-        }
-    }
-  std::copy(tmp,tmp+nbTuples*nbOfCompo,getPointer());
-  delete [] tmp;
-  declareAsNew();
+  if(!other)
+    throw INTERP_KERNEL::Exception("DataArrayDouble::areIncludedInMe : input array is NULL !");
+  checkAllocated(); other->checkAllocated();
+  if(getNumberOfComponents()!=other->getNumberOfComponents())
+    throw INTERP_KERNEL::Exception("DataArrayDouble::areIncludedInMe : the number of components does not match !");
+  MCAuto<DataArrayDouble> a=DataArrayDouble::Aggregate(this,other);
+  DataArrayInt *c=0,*ci=0;
+  a->findCommonTuples(prec,getNumberOfTuples(),c,ci);
+  MCAuto<DataArrayInt> cSafe(c),ciSafe(ci);
+  int newNbOfTuples=-1;
+  MCAuto<DataArrayInt> ids=DataArrayInt::ConvertIndexArrayToO2N(a->getNumberOfTuples(),c->begin(),ci->begin(),ci->end(),newNbOfTuples);
+  MCAuto<DataArrayInt> ret1=ids->selectByTupleIdSafeSlice(getNumberOfTuples(),a->getNumberOfTuples(),1);
+  tupleIds=ret1.retn();
+  return newNbOfTuples==getNumberOfTuples();
 }
 
 /*!
- * Returns a copy of \a this array with values permuted as required by \a old2New array.
- * The values are permuted so that  \c new[ \a old2New[ i ]] = \c old[ i ].
- * Number of tuples in the result array remains the same as in \c this one.
- * If a permutation reduction is needed, renumberAndReduce() should be used.
- * For more info on renumbering see \ref numbering.
- *  \param [in] old2New - C array of length equal to \a this->getNumberOfTuples()
- *          giving a new position for i-th old value.
- *  \return DataArrayDouble * - the new instance of DataArrayDouble that the caller
- *          is to delete using decrRef() as it is no more needed.
+ * Searches for tuples coincident within \a prec tolerance. Each tuple is considered
+ * as coordinates of a point in getNumberOfComponents()-dimensional space. The
+ * distance separating two points is computed with the infinite norm.
+ *
+ * Indices of coincident tuples are stored in output arrays.
+ * A pair of arrays (\a comm, \a commIndex) is called "Surjective Format 2".
+ *
+ * This method is typically used by MEDCouplingPointSet::findCommonNodes() and
+ * MEDCouplingUMesh::mergeNodes().
+ *  \param [in] prec - minimal absolute distance between two tuples (infinite norm) at which they are
+ *              considered not coincident.
+ *  \param [in] limitTupleId - limit tuple id. If all tuples within a group of coincident
+ *              tuples have id strictly lower than \a limitTupleId then they are not returned.
+ *  \param [out] comm - the array holding ids (== indices) of coincident tuples. 
+ *               \a comm->getNumberOfComponents() == 1. 
+ *               \a comm->getNumberOfTuples() == \a commIndex->back().
+ *  \param [out] commIndex - the array dividing all indices stored in \a comm into
+ *               groups of (indices of) coincident tuples. Its every value is a tuple
+ *               index where a next group of tuples begins. For example the second
+ *               group of tuples in \a comm is described by following range of indices:
+ *               [ \a commIndex[1], \a commIndex[2] ). \a commIndex->getNumberOfTuples()-1
+ *               gives the number of groups of coincident tuples.
  *  \throw If \a this is not allocated.
+ *  \throw If the number of components is not in [1,2,3,4].
+ *
+ *  \if ENABLE_EXAMPLES
+ *  \ref cpp_mcdataarraydouble_findcommontuples "Here is a C++ example".
+ *
+ *  \ref py_mcdataarraydouble_findcommontuples  "Here is a Python example".
+ *  \endif
+ *  \sa DataArrayInt::ConvertIndexArrayToO2N(), DataArrayDouble::areIncludedInMe
  */
-DataArrayDouble *DataArrayDouble::renumber(const int *old2New) const
+void DataArrayDouble::findCommonTuples(double prec, int limitTupleId, DataArrayInt *&comm, DataArrayInt *&commIndex) const
 {
   checkAllocated();
-  int nbTuples=getNumberOfTuples();
   int nbOfCompo=getNumberOfComponents();
-  MCAuto<DataArrayDouble> ret=DataArrayDouble::New();
-  ret->alloc(nbTuples,nbOfCompo);
-  ret->copyStringInfoFrom(*this);
-  const double *iptr=getConstPointer();
-  double *optr=ret->getPointer();
-  for(int i=0;i<nbTuples;i++)
-    std::copy(iptr+nbOfCompo*i,iptr+nbOfCompo*(i+1),optr+nbOfCompo*old2New[i]);
-  ret->copyStringInfoFrom(*this);
-  return ret.retn();
-}
-
-/*!
- * Returns a copy of \a this array with values permuted as required by \a new2Old array.
- * The values are permuted so that  \c new[ i ] = \c old[ \a new2Old[ i ]]. Number of
- * tuples in the result array remains the same as in \c this one.
- * If a permutation reduction is needed, subArray() or selectByTupleId() should be used.
- * For more info on renumbering see \ref numbering.
- *  \param [in] new2Old - C array of length equal to \a this->getNumberOfTuples()
- *     giving a previous position of i-th new value.
- *  \return DataArrayDouble * - the new instance of DataArrayDouble that the caller
- *          is to delete using decrRef() as it is no more needed.
- */
-DataArrayDouble *DataArrayDouble::renumberR(const int *new2Old) const
-{
-  checkAllocated();
-  int nbTuples=getNumberOfTuples();
-  int nbOfCompo=getNumberOfComponents();
-  MCAuto<DataArrayDouble> ret=DataArrayDouble::New();
-  ret->alloc(nbTuples,nbOfCompo);
-  ret->copyStringInfoFrom(*this);
-  const double *iptr=getConstPointer();
-  double *optr=ret->getPointer();
-  for(int i=0;i<nbTuples;i++)
-    std::copy(iptr+nbOfCompo*new2Old[i],iptr+nbOfCompo*(new2Old[i]+1),optr+i*nbOfCompo);
-  ret->copyStringInfoFrom(*this);
-  return ret.retn();
-}
-
-/*!
- * Returns a shorten and permuted copy of \a this array. The new DataArrayDouble is
- * of size \a newNbOfTuple and it's values are permuted as required by \a old2New array.
- * The values are permuted so that  \c new[ \a old2New[ i ]] = \c old[ i ] for all
- * \a old2New[ i ] >= 0. In other words every i-th tuple in \a this array, for which 
- * \a old2New[ i ] is negative, is missing from the result array.
- * For more info on renumbering see \ref numbering.
- *  \param [in] old2New - C array of length equal to \a this->getNumberOfTuples()
- *     giving a new position for i-th old tuple and giving negative position for
- *     for i-th old tuple that should be omitted.
- *  \return DataArrayDouble * - the new instance of DataArrayDouble that the caller
- *          is to delete using decrRef() as it is no more needed.
- */
-DataArrayDouble *DataArrayDouble::renumberAndReduce(const int *old2New, int newNbOfTuple) const
-{
-  checkAllocated();
-  int nbTuples=getNumberOfTuples();
-  int nbOfCompo=getNumberOfComponents();
-  MCAuto<DataArrayDouble> ret=DataArrayDouble::New();
-  ret->alloc(newNbOfTuple,nbOfCompo);
-  const double *iptr=getConstPointer();
-  double *optr=ret->getPointer();
-  for(int i=0;i<nbTuples;i++)
-    {
-      int w=old2New[i];
-      if(w>=0)
-        std::copy(iptr+i*nbOfCompo,iptr+(i+1)*nbOfCompo,optr+w*nbOfCompo);
-    }
-  ret->copyStringInfoFrom(*this);
-  return ret.retn();
-}
-
-/*!
- * Returns a shorten and permuted copy of \a this array. The new DataArrayDouble is
- * of size \a new2OldEnd - \a new2OldBg and it's values are permuted as required by
- * \a new2OldBg array.
- * The values are permuted so that  \c new[ i ] = \c old[ \a new2OldBg[ i ]].
- * This method is equivalent to renumberAndReduce() except that convention in input is
- * \c new2old and \b not \c old2new.
- * For more info on renumbering see \ref numbering.
- *  \param [in] new2OldBg - pointer to the beginning of a permutation array that gives a
- *              tuple index in \a this array to fill the i-th tuple in the new array.
- *  \param [in] new2OldEnd - specifies the end of the permutation array that starts at
- *              \a new2OldBg, so that pointer to a tuple index (\a pi) varies as this:
- *              \a new2OldBg <= \a pi < \a new2OldEnd.
- *  \return DataArrayDouble * - the new instance of DataArrayDouble that the caller
- *          is to delete using decrRef() as it is no more needed.
- */
-DataArrayDouble *DataArrayDouble::selectByTupleId(const int *new2OldBg, const int *new2OldEnd) const
-{
-  checkAllocated();
-  MCAuto<DataArrayDouble> ret=DataArrayDouble::New();
-  int nbComp=getNumberOfComponents();
-  ret->alloc((int)std::distance(new2OldBg,new2OldEnd),nbComp);
-  ret->copyStringInfoFrom(*this);
-  double *pt=ret->getPointer();
-  const double *srcPt=getConstPointer();
-  int i=0;
-  for(const int *w=new2OldBg;w!=new2OldEnd;w++,i++)
-    std::copy(srcPt+(*w)*nbComp,srcPt+((*w)+1)*nbComp,pt+i*nbComp);
-  ret->copyStringInfoFrom(*this);
-  return ret.retn();
-}
-
-DataArrayDouble *DataArrayDouble::selectByTupleId(const DataArrayInt & di) const
-{
-  return selectByTupleId(di.getConstPointer(), di.getConstPointer()+di.getNumberOfTuples());
-}
-
-/*!
- * Returns a shorten and permuted copy of \a this array. The new DataArrayDouble is
- * of size \a new2OldEnd - \a new2OldBg and it's values are permuted as required by
- * \a new2OldBg array.
- * The values are permuted so that  \c new[ i ] = \c old[ \a new2OldBg[ i ]].
- * This method is equivalent to renumberAndReduce() except that convention in input is
- * \c new2old and \b not \c old2new.
- * This method is equivalent to selectByTupleId() except that it prevents coping data
- * from behind the end of \a this array.
- * For more info on renumbering see \ref numbering.
- *  \param [in] new2OldBg - pointer to the beginning of a permutation array that gives a
- *              tuple index in \a this array to fill the i-th tuple in the new array.
- *  \param [in] new2OldEnd - specifies the end of the permutation array that starts at
- *              \a new2OldBg, so that pointer to a tuple index (\a pi) varies as this:
- *              \a new2OldBg <= \a pi < \a new2OldEnd.
- *  \return DataArrayDouble * - the new instance of DataArrayDouble that the caller
- *          is to delete using decrRef() as it is no more needed.
- *  \throw If \a new2OldEnd - \a new2OldBg > \a this->getNumberOfTuples().
- */
-DataArrayDouble *DataArrayDouble::selectByTupleIdSafe(const int *new2OldBg, const int *new2OldEnd) const
-{
-  checkAllocated();
-  MCAuto<DataArrayDouble> ret=DataArrayDouble::New();
-  int nbComp=getNumberOfComponents();
-  int oldNbOfTuples=getNumberOfTuples();
-  ret->alloc((int)std::distance(new2OldBg,new2OldEnd),nbComp);
-  ret->copyStringInfoFrom(*this);
-  double *pt=ret->getPointer();
-  const double *srcPt=getConstPointer();
-  int i=0;
-  for(const int *w=new2OldBg;w!=new2OldEnd;w++,i++)
-    if(*w>=0 && *w<oldNbOfTuples)
-      std::copy(srcPt+(*w)*nbComp,srcPt+((*w)+1)*nbComp,pt+i*nbComp);
-    else
-      throw INTERP_KERNEL::Exception("DataArrayDouble::selectByTupleIdSafe : some ids has been detected to be out of [0,this->getNumberOfTuples) !");
-  ret->copyStringInfoFrom(*this);
-  return ret.retn();
-}
-
-/*!
- * Returns a shorten copy of \a this array. The new DataArrayDouble contains every
- * (\a bg + \c i * \a step)-th tuple of \a this array located before the \a end2-th
- * tuple. Indices of the selected tuples are the same as ones returned by the Python
- * command \c range( \a bg, \a end2, \a step ).
- * This method is equivalent to selectByTupleIdSafe() except that the input array is
- * not constructed explicitly.
- * For more info on renumbering see \ref numbering.
- *  \param [in] bg - index of the first tuple to copy from \a this array.
- *  \param [in] end2 - index of the tuple before which the tuples to copy are located.
- *  \param [in] step - index increment to get index of the next tuple to copy.
- *  \return DataArrayDouble * - the new instance of DataArrayDouble that the caller
- *          is to delete using decrRef() as it is no more needed.
- *  \sa DataArrayDouble::subArray.
- */
-DataArrayDouble *DataArrayDouble::selectByTupleIdSafeSlice(int bg, int end2, int step) const
-{
-  checkAllocated();
-  MCAuto<DataArrayDouble> ret=DataArrayDouble::New();
-  int nbComp=getNumberOfComponents();
-  int newNbOfTuples=GetNumberOfItemGivenBESRelative(bg,end2,step,"DataArrayDouble::selectByTupleIdSafeSlice : ");
-  ret->alloc(newNbOfTuples,nbComp);
-  double *pt=ret->getPointer();
-  const double *srcPt=getConstPointer()+bg*nbComp;
-  for(int i=0;i<newNbOfTuples;i++,srcPt+=step*nbComp)
-    std::copy(srcPt,srcPt+nbComp,pt+i*nbComp);
-  ret->copyStringInfoFrom(*this);
-  return ret.retn();
-}
-
-/*!
- * Returns a shorten copy of \a this array. The new DataArrayDouble contains ranges
- * of tuples specified by \a ranges parameter.
- * For more info on renumbering see \ref numbering.
- *  \param [in] ranges - std::vector of std::pair's each of which defines a range
- *              of tuples in [\c begin,\c end) format.
- *  \return DataArrayDouble * - the new instance of DataArrayDouble that the caller
- *          is to delete using decrRef() as it is no more needed.
- *  \throw If \a end < \a begin.
- *  \throw If \a end > \a this->getNumberOfTuples().
- *  \throw If \a this is not allocated.
- */
-DataArray *DataArrayDouble::selectByTupleRanges(const std::vector<std::pair<int,int> >& ranges) const
-{
-  checkAllocated();
-  int nbOfComp=getNumberOfComponents();
-  int nbOfTuplesThis=getNumberOfTuples();
-  if(ranges.empty())
-    {
-      DataArrayDouble *ret=DataArrayDouble::New();
-      ret->alloc(0,nbOfComp);
-      ret->copyStringInfoFrom(*this);
-      return ret;
-    }
-  int ref=ranges.front().first;
-  int nbOfTuples=0;
-  bool isIncreasing=true;
-  for(std::vector<std::pair<int,int> >::const_iterator it=ranges.begin();it!=ranges.end();it++)
-    {
-      if((*it).first<=(*it).second)
-        {
-          if((*it).first>=0 && (*it).second<=nbOfTuplesThis)
-            {
-              nbOfTuples+=(*it).second-(*it).first;
-              if(isIncreasing)
-                isIncreasing=ref<=(*it).first;
-              ref=(*it).second;
-            }
-          else
-            {
-              std::ostringstream oss; oss << "DataArrayDouble::selectByTupleRanges : on range #" << std::distance(ranges.begin(),it);
-              oss << " (" << (*it).first << "," << (*it).second << ") is greater than number of tuples of this :" << nbOfTuples << " !";
-              throw INTERP_KERNEL::Exception(oss.str().c_str());
-            }
-        }
-      else
-        {
-          std::ostringstream oss; oss << "DataArrayDouble::selectByTupleRanges : on range #" << std::distance(ranges.begin(),it);
-          oss << " (" << (*it).first << "," << (*it).second << ") end is before begin !";
-          throw INTERP_KERNEL::Exception(oss.str().c_str());
-        }
-    }
-  if(isIncreasing && nbOfTuplesThis==nbOfTuples)
-    return deepCopy();
-  MCAuto<DataArrayDouble> ret=DataArrayDouble::New();
-  ret->alloc(nbOfTuples,nbOfComp);
-  ret->copyStringInfoFrom(*this);
-  const double *src=getConstPointer();
-  double *work=ret->getPointer();
-  for(std::vector<std::pair<int,int> >::const_iterator it=ranges.begin();it!=ranges.end();it++)
-    work=std::copy(src+(*it).first*nbOfComp,src+(*it).second*nbOfComp,work);
-  return ret.retn();
-}
-
-/*!
- * Returns a shorten copy of \a this array. The new DataArrayDouble contains all
- * tuples starting from the \a tupleIdBg-th tuple and including all tuples located before
- * the \a tupleIdEnd-th one. This methods has a similar behavior as std::string::substr().
- * This method is a specialization of selectByTupleIdSafeSlice().
- *  \param [in] tupleIdBg - index of the first tuple to copy from \a this array.
- *  \param [in] tupleIdEnd - index of the tuple before which the tuples to copy are located.
- *          If \a tupleIdEnd == -1, all the tuples till the end of \a this array are copied.
- *  \return DataArrayDouble * - the new instance of DataArrayDouble that the caller
- *          is to delete using decrRef() as it is no more needed.
- *  \throw If \a tupleIdBg < 0.
- *  \throw If \a tupleIdBg > \a this->getNumberOfTuples().
-    \throw If \a tupleIdEnd != -1 && \a tupleIdEnd < \a this->getNumberOfTuples().
- *  \sa DataArrayDouble::selectByTupleIdSafeSlice
- */
-DataArrayDouble *DataArrayDouble::subArray(int tupleIdBg, int tupleIdEnd) const
-{
-  checkAllocated();
-  int nbt=getNumberOfTuples();
-  if(tupleIdBg<0)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::subArray : The tupleIdBg parameter must be greater than 0 !");
-  if(tupleIdBg>nbt)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::subArray : The tupleIdBg parameter is greater than number of tuples !");
-  int trueEnd=tupleIdEnd;
-  if(tupleIdEnd!=-1)
-    {
-      if(tupleIdEnd>nbt)
-        throw INTERP_KERNEL::Exception("DataArrayDouble::subArray : The tupleIdBg parameter is greater or equal than number of tuples !");
-    }
-  else
-    trueEnd=nbt;
-  int nbComp=getNumberOfComponents();
-  MCAuto<DataArrayDouble> ret=DataArrayDouble::New();
-  ret->alloc(trueEnd-tupleIdBg,nbComp);
-  ret->copyStringInfoFrom(*this);
-  std::copy(getConstPointer()+tupleIdBg*nbComp,getConstPointer()+trueEnd*nbComp,ret->getPointer());
-  return ret.retn();
-}
-
-/*!
- * Returns a shorten or extended copy of \a this array. If \a newNbOfComp is less
- * than \a this->getNumberOfComponents() then the result array is shorten as each tuple
- * is truncated to have \a newNbOfComp components, keeping first components. If \a
- * newNbOfComp is more than \a this->getNumberOfComponents() then the result array is
- * expanded as each tuple is populated with \a dftValue to have \a newNbOfComp
- * components.  
- *  \param [in] newNbOfComp - number of components for the new array to have.
- *  \param [in] dftValue - value assigned to new values added to the new array.
- *  \return DataArrayDouble * - the new instance of DataArrayDouble that the caller
- *          is to delete using decrRef() as it is no more needed.
- *  \throw If \a this is not allocated.
- */
-DataArrayDouble *DataArrayDouble::changeNbOfComponents(int newNbOfComp, double dftValue) const
-{
-  checkAllocated();
-  MCAuto<DataArrayDouble> ret=DataArrayDouble::New();
-  ret->alloc(getNumberOfTuples(),newNbOfComp);
-  const double *oldc=getConstPointer();
-  double *nc=ret->getPointer();
-  int nbOfTuples=getNumberOfTuples();
-  int oldNbOfComp=getNumberOfComponents();
-  int dim=std::min(oldNbOfComp,newNbOfComp);
-  for(int i=0;i<nbOfTuples;i++)
-    {
-      int j=0;
-      for(;j<dim;j++)
-        nc[newNbOfComp*i+j]=oldc[i*oldNbOfComp+j];
-      for(;j<newNbOfComp;j++)
-        nc[newNbOfComp*i+j]=dftValue;
-    }
-  ret->setName(getName());
-  for(int i=0;i<dim;i++)
-    ret->setInfoOnComponent(i,getInfoOnComponent(i));
-  ret->setName(getName());
-  return ret.retn();
-}
-
-/*!
- * Changes the number of components within \a this array so that its raw data **does
- * not** change, instead splitting this data into tuples changes.
- *  \warning This method erases all (name and unit) component info set before!
- *  \param [in] newNbOfComp - number of components for \a this array to have.
- *  \throw If \a this is not allocated
- *  \throw If getNbOfElems() % \a newNbOfCompo != 0.
- *  \throw If \a newNbOfCompo is lower than 1.
- *  \throw If the rearrange method would lead to a number of tuples higher than 2147483647 (maximal capacity of int32 !).
- *  \warning This method erases all (name and unit) component info set before!
- */
-void DataArrayDouble::rearrange(int newNbOfCompo)
-{
-  checkAllocated();
-  if(newNbOfCompo<1)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::rearrange : input newNbOfCompo must be > 0 !");
-  std::size_t nbOfElems=getNbOfElems();
-  if(nbOfElems%newNbOfCompo!=0)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::rearrange : nbOfElems%newNbOfCompo!=0 !");
-  if(nbOfElems/newNbOfCompo>(std::size_t)std::numeric_limits<int>::max())
-    throw INTERP_KERNEL::Exception("DataArrayDouble::rearrange : the rearrangement leads to too high number of tuples (> 2147483647) !");
-  _info_on_compo.clear();
-  _info_on_compo.resize(newNbOfCompo);
-  declareAsNew();
-}
-
-/*!
- * Changes the number of components within \a this array to be equal to its number
- * of tuples, and inversely its number of tuples to become equal to its number of 
- * components. So that its raw data **does not** change, instead splitting this
- * data into tuples changes.
- *  \warning This method erases all (name and unit) component info set before!
- *  \warning Do not confuse this method with fromNoInterlace() and toNoInterlace()!
- *  \throw If \a this is not allocated.
- *  \sa rearrange()
- */
-void DataArrayDouble::transpose()
-{
-  checkAllocated();
-  int nbOfTuples=getNumberOfTuples();
-  rearrange(nbOfTuples);
-}
-
-/*!
- * Returns a copy of \a this array composed of selected components.
- * The new DataArrayDouble has the same number of tuples but includes components
- * specified by \a compoIds parameter. So that getNbOfElems() of the result array
- * can be either less, same or more than \a this->getNbOfElems().
- *  \param [in] compoIds - sequence of zero based indices of components to include
- *              into the new array.
- *  \return DataArrayDouble * - the new instance of DataArrayDouble that the caller
- *          is to delete using decrRef() as it is no more needed.
- *  \throw If \a this is not allocated.
- *  \throw If a component index (\a i) is not valid: 
- *         \a i < 0 || \a i >= \a this->getNumberOfComponents().
- *
- *  \if ENABLE_EXAMPLES
- *  \ref py_mcdataarraydouble_KeepSelectedComponents "Here is a Python example".
- *  \endif
- */
-DataArrayDouble *DataArrayDouble::keepSelectedComponents(const std::vector<int>& compoIds) const
-{
-  checkAllocated();
-  MCAuto<DataArrayDouble> ret(DataArrayDouble::New());
-  std::size_t newNbOfCompo=compoIds.size();
-  int oldNbOfCompo=getNumberOfComponents();
-  for(std::vector<int>::const_iterator it=compoIds.begin();it!=compoIds.end();it++)
-    if((*it)<0 || (*it)>=oldNbOfCompo)
-      {
-        std::ostringstream oss; oss << "DataArrayDouble::keepSelectedComponents : invalid requested component : " << *it << " whereas it should be in [0," << oldNbOfCompo << ") !";
-        throw INTERP_KERNEL::Exception(oss.str().c_str());
-      }
-  int nbOfTuples=getNumberOfTuples();
-  ret->alloc(nbOfTuples,(int)newNbOfCompo);
-  ret->copyPartOfStringInfoFrom(*this,compoIds);
-  const double *oldc=getConstPointer();
-  double *nc=ret->getPointer();
-  for(int i=0;i<nbOfTuples;i++)
-    for(std::size_t j=0;j<newNbOfCompo;j++,nc++)
-      *nc=oldc[i*oldNbOfCompo+compoIds[j]];
-  return ret.retn();
-}
-
-/*!
- * Appends components of another array to components of \a this one, tuple by tuple.
- * So that the number of tuples of \a this array remains the same and the number of 
- * components increases.
- *  \param [in] other - the DataArrayDouble to append to \a this one.
- *  \throw If \a this is not allocated.
- *  \throw If \a this and \a other arrays have different number of tuples.
- *
- *  \if ENABLE_EXAMPLES
- *  \ref cpp_mcdataarraydouble_meldwith "Here is a C++ example".
- *
- *  \ref py_mcdataarraydouble_meldwith "Here is a Python example".
- *  \endif
- */
-void DataArrayDouble::meldWith(const DataArrayDouble *other)
-{
-  checkAllocated();
-  other->checkAllocated();
-  int nbOfTuples=getNumberOfTuples();
-  if(nbOfTuples!=other->getNumberOfTuples())
-    throw INTERP_KERNEL::Exception("DataArrayDouble::meldWith : mismatch of number of tuples !");
-  int nbOfComp1=getNumberOfComponents();
-  int nbOfComp2=other->getNumberOfComponents();
-  double *newArr=(double *)malloc((nbOfTuples*(nbOfComp1+nbOfComp2))*sizeof(double));
-  double *w=newArr;
-  const double *inp1=getConstPointer();
-  const double *inp2=other->getConstPointer();
-  for(int i=0;i<nbOfTuples;i++,inp1+=nbOfComp1,inp2+=nbOfComp2)
-    {
-      w=std::copy(inp1,inp1+nbOfComp1,w);
-      w=std::copy(inp2,inp2+nbOfComp2,w);
-    }
-  useArray(newArr,true,C_DEALLOC,nbOfTuples,nbOfComp1+nbOfComp2);
-  std::vector<int> compIds(nbOfComp2);
-  for(int i=0;i<nbOfComp2;i++)
-    compIds[i]=nbOfComp1+i;
-  copyPartOfStringInfoFrom2(compIds,*other);
-}
-
-/*!
- * This method checks that all tuples in \a other are in \a this.
- * If true, the output param \a tupleIds contains the tuples ids of \a this that correspond to tupes in \a this.
- * For each i in [ 0 , other->getNumberOfTuples() ) tuple #i in \a other is equal ( regarding input precision \a prec ) to tuple tupleIds[i] in \a this.
- *
- * \param [in] other - the array having the same number of components than \a this.
- * \param [out] tupleIds - the tuple ids containing the same number of tuples than \a other has.
- * \sa DataArrayDouble::findCommonTuples
- */
-bool DataArrayDouble::areIncludedInMe(const DataArrayDouble *other, double prec, DataArrayInt *&tupleIds) const
-{
-  if(!other)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::areIncludedInMe : input array is NULL !");
-  checkAllocated(); other->checkAllocated();
-  if(getNumberOfComponents()!=other->getNumberOfComponents())
-    throw INTERP_KERNEL::Exception("DataArrayDouble::areIncludedInMe : the number of components does not match !");
-  MCAuto<DataArrayDouble> a=DataArrayDouble::Aggregate(this,other);
-  DataArrayInt *c=0,*ci=0;
-  a->findCommonTuples(prec,getNumberOfTuples(),c,ci);
-  MCAuto<DataArrayInt> cSafe(c),ciSafe(ci);
-  int newNbOfTuples=-1;
-  MCAuto<DataArrayInt> ids=DataArrayInt::ConvertIndexArrayToO2N(a->getNumberOfTuples(),c->begin(),ci->begin(),ci->end(),newNbOfTuples);
-  MCAuto<DataArrayInt> ret1=ids->selectByTupleIdSafeSlice(getNumberOfTuples(),a->getNumberOfTuples(),1);
-  tupleIds=ret1.retn();
-  return newNbOfTuples==getNumberOfTuples();
-}
-
-/*!
- * Searches for tuples coincident within \a prec tolerance. Each tuple is considered
- * as coordinates of a point in getNumberOfComponents()-dimensional space. The
- * distance separating two points is computed with the infinite norm.
- *
- * Indices of coincident tuples are stored in output arrays.
- * A pair of arrays (\a comm, \a commIndex) is called "Surjective Format 2".
- *
- * This method is typically used by MEDCouplingPointSet::findCommonNodes() and
- * MEDCouplingUMesh::mergeNodes().
- *  \param [in] prec - minimal absolute distance between two tuples (infinite norm) at which they are
- *              considered not coincident.
- *  \param [in] limitTupleId - limit tuple id. If all tuples within a group of coincident
- *              tuples have id strictly lower than \a limitTupleId then they are not returned.
- *  \param [out] comm - the array holding ids (== indices) of coincident tuples. 
- *               \a comm->getNumberOfComponents() == 1. 
- *               \a comm->getNumberOfTuples() == \a commIndex->back().
- *  \param [out] commIndex - the array dividing all indices stored in \a comm into
- *               groups of (indices of) coincident tuples. Its every value is a tuple
- *               index where a next group of tuples begins. For example the second
- *               group of tuples in \a comm is described by following range of indices:
- *               [ \a commIndex[1], \a commIndex[2] ). \a commIndex->getNumberOfTuples()-1
- *               gives the number of groups of coincident tuples.
- *  \throw If \a this is not allocated.
- *  \throw If the number of components is not in [1,2,3,4].
- *
- *  \if ENABLE_EXAMPLES
- *  \ref cpp_mcdataarraydouble_findcommontuples "Here is a C++ example".
- *
- *  \ref py_mcdataarraydouble_findcommontuples  "Here is a Python example".
- *  \endif
- *  \sa DataArrayInt::ConvertIndexArrayToO2N(), DataArrayDouble::areIncludedInMe
- */
-void DataArrayDouble::findCommonTuples(double prec, int limitTupleId, DataArrayInt *&comm, DataArrayInt *&commIndex) const
-{
-  checkAllocated();
-  int nbOfCompo=getNumberOfComponents();
-  if ((nbOfCompo<1) || (nbOfCompo>4)) //test before work
-    throw INTERP_KERNEL::Exception("DataArrayDouble::findCommonTuples : Unexpected spacedim of coords. Must be 1, 2, 3 or 4.");
+  if ((nbOfCompo<1) || (nbOfCompo>4)) //test before work
+    throw INTERP_KERNEL::Exception("DataArrayDouble::findCommonTuples : Unexpected spacedim of coords. Must be 1, 2, 3 or 4.");
 
   int nbOfTuples=getNumberOfTuples();
   //
@@ -2243,784 +1509,71 @@ DataArrayInt *DataArrayDouble::computeNbOfInteractionsWith(const DataArrayDouble
       }
     default:
       throw INTERP_KERNEL::Exception("DataArrayDouble::computeNbOfInteractionsWith : space dimension supported are [1,2,3] !");
-  }
-
-  return ret.retn();
-}
-
-/*!
- * Returns a copy of \a this array by excluding coincident tuples. Each tuple is
- * considered as coordinates of a point in getNumberOfComponents()-dimensional
- * space. The distance between tuples is computed using norm2. If several tuples are
- * not far each from other than \a prec, only one of them remains in the result
- * array. The order of tuples in the result array is same as in \a this one except
- * that coincident tuples are excluded.
- *  \param [in] prec - minimal absolute distance between two tuples at which they are
- *              considered not coincident.
- *  \param [in] limitTupleId - limit tuple id. If all tuples within a group of coincident
- *              tuples have id strictly lower than \a limitTupleId then they are not excluded.
- *  \return DataArrayDouble * - the new instance of DataArrayDouble that the caller
- *          is to delete using decrRef() as it is no more needed.
- *  \throw If \a this is not allocated.
- *  \throw If the number of components is not in [1,2,3,4].
- *
- *  \if ENABLE_EXAMPLES
- *  \ref py_mcdataarraydouble_getdifferentvalues "Here is a Python example".
- *  \endif
- */
-DataArrayDouble *DataArrayDouble::getDifferentValues(double prec, int limitTupleId) const
-{
-  checkAllocated();
-  DataArrayInt *c0=0,*cI0=0;
-  findCommonTuples(prec,limitTupleId,c0,cI0);
-  MCAuto<DataArrayInt> c(c0),cI(cI0);
-  int newNbOfTuples=-1;
-  MCAuto<DataArrayInt> o2n=DataArrayInt::ConvertIndexArrayToO2N(getNumberOfTuples(),c0->begin(),cI0->begin(),cI0->end(),newNbOfTuples);
-  return renumberAndReduce(o2n->getConstPointer(),newNbOfTuples);
-}
-
-/*!
- * Copy all components in a specified order from another DataArrayDouble.
- * Both numerical and textual data is copied. The number of tuples in \a this and
- * the other array can be different.
- *  \param [in] a - the array to copy data from.
- *  \param [in] compoIds - sequence of zero based indices of components, data of which is
- *              to be copied.
- *  \throw If \a a is NULL.
- *  \throw If \a compoIds.size() != \a a->getNumberOfComponents().
- *  \throw If \a compoIds[i] < 0 or \a compoIds[i] > \a this->getNumberOfComponents().
- *
- *  \if ENABLE_EXAMPLES
- *  \ref py_mcdataarraydouble_setselectedcomponents "Here is a Python example".
- *  \endif
- */
-void DataArrayDouble::setSelectedComponents(const DataArrayDouble *a, const std::vector<int>& compoIds)
-{
-  if(!a)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::setSelectedComponents : input DataArrayDouble is NULL !");
-  checkAllocated();
-  copyPartOfStringInfoFrom2(compoIds,*a);
-  std::size_t partOfCompoSz=compoIds.size();
-  int nbOfCompo=getNumberOfComponents();
-  int nbOfTuples=std::min(getNumberOfTuples(),a->getNumberOfTuples());
-  const double *ac=a->getConstPointer();
-  double *nc=getPointer();
-  for(int i=0;i<nbOfTuples;i++)
-    for(std::size_t j=0;j<partOfCompoSz;j++,ac++)
-      nc[nbOfCompo*i+compoIds[j]]=*ac;
-}
-
-/*!
- * Copy all values from another DataArrayDouble into specified tuples and components
- * of \a this array. Textual data is not copied.
- * The tree parameters defining set of indices of tuples and components are similar to
- * the tree parameters of the Python function \c range(\c start,\c stop,\c step).
- *  \param [in] a - the array to copy values from.
- *  \param [in] bgTuples - index of the first tuple of \a this array to assign values to.
- *  \param [in] endTuples - index of the tuple before which the tuples to assign to
- *              are located.
- *  \param [in] stepTuples - index increment to get index of the next tuple to assign to.
- *  \param [in] bgComp - index of the first component of \a this array to assign values to.
- *  \param [in] endComp - index of the component before which the components to assign
- *              to are located.
- *  \param [in] stepComp - index increment to get index of the next component to assign to.
- *  \param [in] strictCompoCompare - if \a true (by default), then \a a->getNumberOfComponents() 
- *              must be equal to the number of columns to assign to, else an
- *              exception is thrown; if \a false, then it is only required that \a
- *              a->getNbOfElems() equals to number of values to assign to (this condition
- *              must be respected even if \a strictCompoCompare is \a true). The number of 
- *              values to assign to is given by following Python expression:
- *              \a nbTargetValues = 
- *              \c len(\c range(\a bgTuples,\a endTuples,\a stepTuples)) *
- *              \c len(\c range(\a bgComp,\a endComp,\a stepComp)).
- *  \throw If \a a is NULL.
- *  \throw If \a a is not allocated.
- *  \throw If \a this is not allocated.
- *  \throw If parameters specifying tuples and components to assign to do not give a
- *            non-empty range of increasing indices.
- *  \throw If \a a->getNbOfElems() != \a nbTargetValues.
- *  \throw If \a strictCompoCompare == \a true && \a a->getNumberOfComponents() !=
- *            \c len(\c range(\a bgComp,\a endComp,\a stepComp)).
- *
- *  \if ENABLE_EXAMPLES
- *  \ref py_mcdataarraydouble_setpartofvalues1 "Here is a Python example".
- *  \endif
- */
-void DataArrayDouble::setPartOfValues1(const DataArrayDouble *a, int bgTuples, int endTuples, int stepTuples, int bgComp, int endComp, int stepComp, bool strictCompoCompare)
-{
-  if(!a)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::setPartOfValues1 : input DataArrayDouble is NULL !");
-  const char msg[]="DataArrayDouble::setPartOfValues1";
-  checkAllocated();
-  a->checkAllocated();
-  int newNbOfTuples=DataArray::GetNumberOfItemGivenBES(bgTuples,endTuples,stepTuples,msg);
-  int newNbOfComp=DataArray::GetNumberOfItemGivenBES(bgComp,endComp,stepComp,msg);
-  int nbComp=getNumberOfComponents();
-  int nbOfTuples=getNumberOfTuples();
-  DataArray::CheckValueInRangeEx(nbOfTuples,bgTuples,endTuples,"invalid tuple value");
-  DataArray::CheckValueInRangeEx(nbComp,bgComp,endComp,"invalid component value");
-  bool assignTech=true;
-  if(a->getNbOfElems()==(std::size_t)newNbOfTuples*newNbOfComp)
-    {
-      if(strictCompoCompare)
-        a->checkNbOfTuplesAndComp(newNbOfTuples,newNbOfComp,msg);
-    }
-  else
-    {
-      a->checkNbOfTuplesAndComp(1,newNbOfComp,msg);
-      assignTech=false;
-    }
-  const double *srcPt=a->getConstPointer();
-  double *pt=getPointer()+bgTuples*nbComp+bgComp;
-  if(assignTech)
-    {
-      for(int i=0;i<newNbOfTuples;i++,pt+=stepTuples*nbComp)
-        for(int j=0;j<newNbOfComp;j++,srcPt++)
-          pt[j*stepComp]=*srcPt;
-    }
-  else
-    {
-      for(int i=0;i<newNbOfTuples;i++,pt+=stepTuples*nbComp)
-        {
-          const double *srcPt2=srcPt;
-          for(int j=0;j<newNbOfComp;j++,srcPt2++)
-            pt[j*stepComp]=*srcPt2;
-        }
-    }
-}
-
-/*!
- * Assign a given value to values at specified tuples and components of \a this array.
- * The tree parameters defining set of indices of tuples and components are similar to
- * the tree parameters of the Python function \c range(\c start,\c stop,\c step)..
- *  \param [in] a - the value to assign.
- *  \param [in] bgTuples - index of the first tuple of \a this array to assign to.
- *  \param [in] endTuples - index of the tuple before which the tuples to assign to
- *              are located.
- *  \param [in] stepTuples - index increment to get index of the next tuple to assign to.
- *  \param [in] bgComp - index of the first component of \a this array to assign to.
- *  \param [in] endComp - index of the component before which the components to assign
- *              to are located.
- *  \param [in] stepComp - index increment to get index of the next component to assign to.
- *  \throw If \a this is not allocated.
- *  \throw If parameters specifying tuples and components to assign to, do not give a
- *            non-empty range of increasing indices or indices are out of a valid range
- *            for \c this array.
- *
- *  \if ENABLE_EXAMPLES
- *  \ref py_mcdataarraydouble_setpartofvaluessimple1 "Here is a Python example".
- *  \endif
- */
-void DataArrayDouble::setPartOfValuesSimple1(double a, int bgTuples, int endTuples, int stepTuples, int bgComp, int endComp, int stepComp)
-{
-  const char msg[]="DataArrayDouble::setPartOfValuesSimple1";
-  checkAllocated();
-  int newNbOfTuples=DataArray::GetNumberOfItemGivenBES(bgTuples,endTuples,stepTuples,msg);
-  int newNbOfComp=DataArray::GetNumberOfItemGivenBES(bgComp,endComp,stepComp,msg);
-  int nbComp=getNumberOfComponents();
-  int nbOfTuples=getNumberOfTuples();
-  DataArray::CheckValueInRangeEx(nbOfTuples,bgTuples,endTuples,"invalid tuple value");
-  DataArray::CheckValueInRangeEx(nbComp,bgComp,endComp,"invalid component value");
-  double *pt=getPointer()+bgTuples*nbComp+bgComp;
-  for(int i=0;i<newNbOfTuples;i++,pt+=stepTuples*nbComp)
-    for(int j=0;j<newNbOfComp;j++)
-      pt[j*stepComp]=a;
-}
-
-/*!
- * Copy all values from another DataArrayDouble (\a a) into specified tuples and 
- * components of \a this array. Textual data is not copied.
- * The tuples and components to assign to are defined by C arrays of indices.
- * There are two *modes of usage*:
- * - If \a a->getNbOfElems() equals to number of values to assign to, then every value
- *   of \a a is assigned to its own location within \a this array. 
- * - If \a a includes one tuple, then all values of \a a are assigned to the specified
- *   components of every specified tuple of \a this array. In this mode it is required
- *   that \a a->getNumberOfComponents() equals to the number of specified components.
- *
- *  \param [in] a - the array to copy values from.
- *  \param [in] bgTuples - pointer to an array of tuple indices of \a this array to
- *              assign values of \a a to.
- *  \param [in] endTuples - specifies the end of the array \a bgTuples, so that
- *              pointer to a tuple index <em>(pi)</em> varies as this: 
- *              \a bgTuples <= \a pi < \a endTuples.
- *  \param [in] bgComp - pointer to an array of component indices of \a this array to
- *              assign values of \a a to.
- *  \param [in] endComp - specifies the end of the array \a bgTuples, so that
- *              pointer to a component index <em>(pi)</em> varies as this: 
- *              \a bgComp <= \a pi < \a endComp.
- *  \param [in] strictCompoCompare - this parameter is checked only if the
- *               *mode of usage* is the first; if it is \a true (default), 
- *               then \a a->getNumberOfComponents() must be equal 
- *               to the number of specified columns, else this is not required.
- *  \throw If \a a is NULL.
- *  \throw If \a a is not allocated.
- *  \throw If \a this is not allocated.
- *  \throw If any index of tuple/component given by <em>bgTuples / bgComp</em> is
- *         out of a valid range for \a this array.
- *  \throw In the first *mode of usage*, if <em>strictCompoCompare == true </em> and
- *         if <em> a->getNumberOfComponents() != (endComp - bgComp) </em>.
- *  \throw In the second *mode of usage*, if \a a->getNumberOfTuples() != 1 or
- *         <em> a->getNumberOfComponents() != (endComp - bgComp)</em>.
- *
- *  \if ENABLE_EXAMPLES
- *  \ref py_mcdataarraydouble_setpartofvalues2 "Here is a Python example".
- *  \endif
- */
-void DataArrayDouble::setPartOfValues2(const DataArrayDouble *a, const int *bgTuples, const int *endTuples, const int *bgComp, const int *endComp, bool strictCompoCompare)
-{
-  if(!a)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::setPartOfValues2 : input DataArrayDouble is NULL !");
-  const char msg[]="DataArrayDouble::setPartOfValues2";
-  checkAllocated();
-  a->checkAllocated();
-  int nbComp=getNumberOfComponents();
-  int nbOfTuples=getNumberOfTuples();
-  for(const int *z=bgComp;z!=endComp;z++)
-    DataArray::CheckValueInRange(nbComp,*z,"invalid component id");
-  int newNbOfTuples=(int)std::distance(bgTuples,endTuples);
-  int newNbOfComp=(int)std::distance(bgComp,endComp);
-  bool assignTech=true;
-  if(a->getNbOfElems()==(std::size_t)newNbOfTuples*newNbOfComp)
-    {
-      if(strictCompoCompare)
-        a->checkNbOfTuplesAndComp(newNbOfTuples,newNbOfComp,msg);
-    }
-  else
-    {
-      a->checkNbOfTuplesAndComp(1,newNbOfComp,msg);
-      assignTech=false;
-    }
-  double *pt=getPointer();
-  const double *srcPt=a->getConstPointer();
-  if(assignTech)
-    {    
-      for(const int *w=bgTuples;w!=endTuples;w++)
-        {
-          DataArray::CheckValueInRange(nbOfTuples,*w,"invalid tuple id");
-          for(const int *z=bgComp;z!=endComp;z++,srcPt++)
-            {    
-              pt[(std::size_t)(*w)*nbComp+(*z)]=*srcPt;
-            }
-        }
-    }
-  else
-    {
-      for(const int *w=bgTuples;w!=endTuples;w++)
-        {
-          const double *srcPt2=srcPt;
-          DataArray::CheckValueInRange(nbOfTuples,*w,"invalid tuple id");
-          for(const int *z=bgComp;z!=endComp;z++,srcPt2++)
-            {    
-              pt[(std::size_t)(*w)*nbComp+(*z)]=*srcPt2;
-            }
-        }
-    }
-}
-
-/*!
- * Assign a given value to values at specified tuples and components of \a this array.
- * The tuples and components to assign to are defined by C arrays of indices.
- *  \param [in] a - the value to assign.
- *  \param [in] bgTuples - pointer to an array of tuple indices of \a this array to
- *              assign \a a to.
- *  \param [in] endTuples - specifies the end of the array \a bgTuples, so that
- *              pointer to a tuple index (\a pi) varies as this: 
- *              \a bgTuples <= \a pi < \a endTuples.
- *  \param [in] bgComp - pointer to an array of component indices of \a this array to
- *              assign \a a to.
- *  \param [in] endComp - specifies the end of the array \a bgTuples, so that
- *              pointer to a component index (\a pi) varies as this: 
- *              \a bgComp <= \a pi < \a endComp.
- *  \throw If \a this is not allocated.
- *  \throw If any index of tuple/component given by <em>bgTuples / bgComp</em> is
- *         out of a valid range for \a this array.
- *
- *  \if ENABLE_EXAMPLES
- *  \ref py_mcdataarraydouble_setpartofvaluessimple2 "Here is a Python example".
- *  \endif
- */
-void DataArrayDouble::setPartOfValuesSimple2(double a, const int *bgTuples, const int *endTuples, const int *bgComp, const int *endComp)
-{
-  checkAllocated();
-  int nbComp=getNumberOfComponents();
-  int nbOfTuples=getNumberOfTuples();
-  for(const int *z=bgComp;z!=endComp;z++)
-    DataArray::CheckValueInRange(nbComp,*z,"invalid component id");
-  double *pt=getPointer();
-  for(const int *w=bgTuples;w!=endTuples;w++)
-    for(const int *z=bgComp;z!=endComp;z++)
-      {
-        DataArray::CheckValueInRange(nbOfTuples,*w,"invalid tuple id");
-        pt[(std::size_t)(*w)*nbComp+(*z)]=a;
-      }
-}
-
-/*!
- * Copy all values from another DataArrayDouble (\a a) into specified tuples and 
- * components of \a this array. Textual data is not copied.
- * The tuples to assign to are defined by a C array of indices.
- * The components to assign to are defined by three values similar to parameters of
- * the Python function \c range(\c start,\c stop,\c step).
- * There are two *modes of usage*:
- * - If \a a->getNbOfElems() equals to number of values to assign to, then every value
- *   of \a a is assigned to its own location within \a this array. 
- * - If \a a includes one tuple, then all values of \a a are assigned to the specified
- *   components of every specified tuple of \a this array. In this mode it is required
- *   that \a a->getNumberOfComponents() equals to the number of specified components.
- *
- *  \param [in] a - the array to copy values from.
- *  \param [in] bgTuples - pointer to an array of tuple indices of \a this array to
- *              assign values of \a a to.
- *  \param [in] endTuples - specifies the end of the array \a bgTuples, so that
- *              pointer to a tuple index <em>(pi)</em> varies as this: 
- *              \a bgTuples <= \a pi < \a endTuples.
- *  \param [in] bgComp - index of the first component of \a this array to assign to.
- *  \param [in] endComp - index of the component before which the components to assign
- *              to are located.
- *  \param [in] stepComp - index increment to get index of the next component to assign to.
- *  \param [in] strictCompoCompare - this parameter is checked only in the first
- *               *mode of usage*; if \a strictCompoCompare is \a true (default), 
- *               then \a a->getNumberOfComponents() must be equal 
- *               to the number of specified columns, else this is not required.
- *  \throw If \a a is NULL.
- *  \throw If \a a is not allocated.
- *  \throw If \a this is not allocated.
- *  \throw If any index of tuple given by \a bgTuples is out of a valid range for 
- *         \a this array.
- *  \throw In the first *mode of usage*, if <em>strictCompoCompare == true </em> and
- *         if <em> a->getNumberOfComponents()</em> is unequal to the number of components
- *         defined by <em>(bgComp,endComp,stepComp)</em>.
- *  \throw In the second *mode of usage*, if \a a->getNumberOfTuples() != 1 or
- *         <em> a->getNumberOfComponents()</em> is unequal to the number of components
- *         defined by <em>(bgComp,endComp,stepComp)</em>.
- *  \throw If parameters specifying components to assign to, do not give a
- *            non-empty range of increasing indices or indices are out of a valid range
- *            for \c this array.
- *
- *  \if ENABLE_EXAMPLES
- *  \ref py_mcdataarraydouble_setpartofvalues3 "Here is a Python example".
- *  \endif
- */
-void DataArrayDouble::setPartOfValues3(const DataArrayDouble *a, const int *bgTuples, const int *endTuples, int bgComp, int endComp, int stepComp, bool strictCompoCompare)
-{
-  if(!a)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::setPartOfValues3 : input DataArrayDouble is NULL !");
-  const char msg[]="DataArrayDouble::setPartOfValues3";
-  checkAllocated();
-  a->checkAllocated();
-  int newNbOfComp=DataArray::GetNumberOfItemGivenBES(bgComp,endComp,stepComp,msg);
-  int nbComp=getNumberOfComponents();
-  int nbOfTuples=getNumberOfTuples();
-  DataArray::CheckValueInRangeEx(nbComp,bgComp,endComp,"invalid component value");
-  int newNbOfTuples=(int)std::distance(bgTuples,endTuples);
-  bool assignTech=true;
-  if(a->getNbOfElems()==(std::size_t)newNbOfTuples*newNbOfComp)
-    {
-      if(strictCompoCompare)
-        a->checkNbOfTuplesAndComp(newNbOfTuples,newNbOfComp,msg);
-    }
-  else
-    {
-      a->checkNbOfTuplesAndComp(1,newNbOfComp,msg);
-      assignTech=false;
-    }
-  double *pt=getPointer()+bgComp;
-  const double *srcPt=a->getConstPointer();
-  if(assignTech)
-    {
-      for(const int *w=bgTuples;w!=endTuples;w++)
-        for(int j=0;j<newNbOfComp;j++,srcPt++)
-          {
-            DataArray::CheckValueInRange(nbOfTuples,*w,"invalid tuple id");
-            pt[(std::size_t)(*w)*nbComp+j*stepComp]=*srcPt;
-          }
-    }
-  else
-    {
-      for(const int *w=bgTuples;w!=endTuples;w++)
-        {
-          const double *srcPt2=srcPt;
-          for(int j=0;j<newNbOfComp;j++,srcPt2++)
-            {
-              DataArray::CheckValueInRange(nbOfTuples,*w,"invalid tuple id");
-              pt[(std::size_t)(*w)*nbComp+j*stepComp]=*srcPt2;
-            }
-        }
-    }
-}
-
-/*!
- * Assign a given value to values at specified tuples and components of \a this array.
- * The tuples to assign to are defined by a C array of indices.
- * The components to assign to are defined by three values similar to parameters of
- * the Python function \c range(\c start,\c stop,\c step).
- *  \param [in] a - the value to assign.
- *  \param [in] bgTuples - pointer to an array of tuple indices of \a this array to
- *              assign \a a to.
- *  \param [in] endTuples - specifies the end of the array \a bgTuples, so that
- *              pointer to a tuple index <em>(pi)</em> varies as this: 
- *              \a bgTuples <= \a pi < \a endTuples.
- *  \param [in] bgComp - index of the first component of \a this array to assign to.
- *  \param [in] endComp - index of the component before which the components to assign
- *              to are located.
- *  \param [in] stepComp - index increment to get index of the next component to assign to.
- *  \throw If \a this is not allocated.
- *  \throw If any index of tuple given by \a bgTuples is out of a valid range for 
- *         \a this array.
- *  \throw If parameters specifying components to assign to, do not give a
- *            non-empty range of increasing indices or indices are out of a valid range
- *            for \c this array.
- *
- *  \if ENABLE_EXAMPLES
- *  \ref py_mcdataarraydouble_setpartofvaluessimple3 "Here is a Python example".
- *  \endif
- */
-void DataArrayDouble::setPartOfValuesSimple3(double a, const int *bgTuples, const int *endTuples, int bgComp, int endComp, int stepComp)
-{
-  const char msg[]="DataArrayDouble::setPartOfValuesSimple3";
-  checkAllocated();
-  int newNbOfComp=DataArray::GetNumberOfItemGivenBES(bgComp,endComp,stepComp,msg);
-  int nbComp=getNumberOfComponents();
-  int nbOfTuples=getNumberOfTuples();
-  DataArray::CheckValueInRangeEx(nbComp,bgComp,endComp,"invalid component value");
-  double *pt=getPointer()+bgComp;
-  for(const int *w=bgTuples;w!=endTuples;w++)
-    for(int j=0;j<newNbOfComp;j++)
-      {
-        DataArray::CheckValueInRange(nbOfTuples,*w,"invalid tuple id");
-        pt[(std::size_t)(*w)*nbComp+j*stepComp]=a;
-      }
-}
-
-/*!
- * Copy all values from another DataArrayDouble into specified tuples and components
- * of \a this array. Textual data is not copied.
- * The tree parameters defining set of indices of tuples and components are similar to
- * the tree parameters of the Python function \c range(\c start,\c stop,\c step).
- *  \param [in] a - the array to copy values from.
- *  \param [in] bgTuples - index of the first tuple of \a this array to assign values to.
- *  \param [in] endTuples - index of the tuple before which the tuples to assign to
- *              are located.
- *  \param [in] stepTuples - index increment to get index of the next tuple to assign to.
- *  \param [in] bgComp - pointer to an array of component indices of \a this array to
- *              assign \a a to.
- *  \param [in] endComp - specifies the end of the array \a bgTuples, so that
- *              pointer to a component index (\a pi) varies as this: 
- *              \a bgComp <= \a pi < \a endComp.
- *  \param [in] strictCompoCompare - if \a true (by default), then \a a->getNumberOfComponents() 
- *              must be equal to the number of columns to assign to, else an
- *              exception is thrown; if \a false, then it is only required that \a
- *              a->getNbOfElems() equals to number of values to assign to (this condition
- *              must be respected even if \a strictCompoCompare is \a true). The number of 
- *              values to assign to is given by following Python expression:
- *              \a nbTargetValues = 
- *              \c len(\c range(\a bgTuples,\a endTuples,\a stepTuples)) *
- *              \c len(\c range(\a bgComp,\a endComp,\a stepComp)).
- *  \throw If \a a is NULL.
- *  \throw If \a a is not allocated.
- *  \throw If \a this is not allocated.
- *  \throw If parameters specifying tuples and components to assign to do not give a
- *            non-empty range of increasing indices.
- *  \throw If \a a->getNbOfElems() != \a nbTargetValues.
- *  \throw If \a strictCompoCompare == \a true && \a a->getNumberOfComponents() !=
- *            \c len(\c range(\a bgComp,\a endComp,\a stepComp)).
- *
- */
-void DataArrayDouble::setPartOfValues4(const DataArrayDouble *a, int bgTuples, int endTuples, int stepTuples, const int *bgComp, const int *endComp, bool strictCompoCompare)
-{
-  if(!a)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::setPartOfValues4 : input DataArrayDouble is NULL !");
-  const char msg[]="DataArrayDouble::setPartOfValues4";
-  checkAllocated();
-  a->checkAllocated();
-  int newNbOfTuples=DataArray::GetNumberOfItemGivenBES(bgTuples,endTuples,stepTuples,msg);
-  int newNbOfComp=(int)std::distance(bgComp,endComp);
-  int nbComp=getNumberOfComponents();
-  for(const int *z=bgComp;z!=endComp;z++)
-    DataArray::CheckValueInRange(nbComp,*z,"invalid component id");
-  int nbOfTuples=getNumberOfTuples();
-  DataArray::CheckValueInRangeEx(nbOfTuples,bgTuples,endTuples,"invalid tuple value");
-  bool assignTech=true;
-  if(a->getNbOfElems()==(std::size_t)newNbOfTuples*newNbOfComp)
-    {
-      if(strictCompoCompare)
-        a->checkNbOfTuplesAndComp(newNbOfTuples,newNbOfComp,msg);
-    }
-  else
-    {
-      a->checkNbOfTuplesAndComp(1,newNbOfComp,msg);
-      assignTech=false;
-    }
-  const double *srcPt=a->getConstPointer();
-  double *pt=getPointer()+bgTuples*nbComp;
-  if(assignTech)
-    {
-      for(int i=0;i<newNbOfTuples;i++,pt+=stepTuples*nbComp)
-        for(const int *z=bgComp;z!=endComp;z++,srcPt++)
-          pt[*z]=*srcPt;
-    }
-  else
-    {
-      for(int i=0;i<newNbOfTuples;i++,pt+=stepTuples*nbComp)
-        {
-          const double *srcPt2=srcPt;
-          for(const int *z=bgComp;z!=endComp;z++,srcPt2++)
-            pt[*z]=*srcPt2;
-        }
-    }
-}
-
-void DataArrayDouble::setPartOfValuesSimple4(double a, int bgTuples, int endTuples, int stepTuples, const int *bgComp, const int *endComp)
-{
-  const char msg[]="DataArrayDouble::setPartOfValuesSimple4";
-  checkAllocated();
-  int newNbOfTuples=DataArray::GetNumberOfItemGivenBES(bgTuples,endTuples,stepTuples,msg);
-  int nbComp=getNumberOfComponents();
-  for(const int *z=bgComp;z!=endComp;z++)
-    DataArray::CheckValueInRange(nbComp,*z,"invalid component id");
-  int nbOfTuples=getNumberOfTuples();
-  DataArray::CheckValueInRangeEx(nbOfTuples,bgTuples,endTuples,"invalid tuple value");
-  double *pt=getPointer()+bgTuples*nbComp;
-  for(int i=0;i<newNbOfTuples;i++,pt+=stepTuples*nbComp)
-    for(const int *z=bgComp;z!=endComp;z++)
-      pt[*z]=a;
-}
-
-/*!
- * Copy some tuples from another DataArrayDouble into specified tuples
- * of \a this array. Textual data is not copied. Both arrays must have equal number of
- * components.
- * Both the tuples to assign and the tuples to assign to are defined by a DataArrayInt.
- * All components of selected tuples are copied.
- *  \param [in] a - the array to copy values from.
- *  \param [in] tuplesSelec - the array specifying both source tuples of \a a and
- *              target tuples of \a this. \a tuplesSelec has two components, and the
- *              first component specifies index of the source tuple and the second
- *              one specifies index of the target tuple.
- *  \throw If \a this is not allocated.
- *  \throw If \a a is NULL.
- *  \throw If \a a is not allocated.
- *  \throw If \a tuplesSelec is NULL.
- *  \throw If \a tuplesSelec is not allocated.
- *  \throw If <em>this->getNumberOfComponents() != a->getNumberOfComponents()</em>.
- *  \throw If \a tuplesSelec->getNumberOfComponents() != 2.
- *  \throw If any tuple index given by \a tuplesSelec is out of a valid range for 
- *         the corresponding (\a this or \a a) array.
- */
-void DataArrayDouble::setPartOfValuesAdv(const DataArrayDouble *a, const DataArrayInt *tuplesSelec)
-{
-  if(!a || !tuplesSelec)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::setPartOfValuesAdv : input DataArrayDouble is NULL !");
-  checkAllocated();
-  a->checkAllocated();
-  tuplesSelec->checkAllocated();
-  int nbOfComp=getNumberOfComponents();
-  if(nbOfComp!=a->getNumberOfComponents())
-    throw INTERP_KERNEL::Exception("DataArrayDouble::setPartOfValuesAdv : This and a do not have the same number of components !");
-  if(tuplesSelec->getNumberOfComponents()!=2)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::setPartOfValuesAdv : Expecting to have a tuple selector DataArrayInt instance with exactly 2 components !");
-  int thisNt=getNumberOfTuples();
-  int aNt=a->getNumberOfTuples();
-  double *valsToSet=getPointer();
-  const double *valsSrc=a->getConstPointer();
-  for(const int *tuple=tuplesSelec->begin();tuple!=tuplesSelec->end();tuple+=2)
-    {
-      if(tuple[1]>=0 && tuple[1]<aNt)
-        {
-          if(tuple[0]>=0 && tuple[0]<thisNt)
-            std::copy(valsSrc+nbOfComp*tuple[1],valsSrc+nbOfComp*(tuple[1]+1),valsToSet+nbOfComp*tuple[0]);
-          else
-            {
-              std::ostringstream oss; oss << "DataArrayDouble::setPartOfValuesAdv : Tuple #" << std::distance(tuplesSelec->begin(),tuple)/2;
-              oss << " of 'tuplesSelec' request of tuple id #" << tuple[0] << " in 'this' ! It should be in [0," << thisNt << ") !";
-              throw INTERP_KERNEL::Exception(oss.str().c_str());
-            }
-        }
-      else
-        {
-          std::ostringstream oss; oss << "DataArrayDouble::setPartOfValuesAdv : Tuple #" << std::distance(tuplesSelec->begin(),tuple)/2;
-          oss << " of 'tuplesSelec' request of tuple id #" << tuple[1] << " in 'a' ! It should be in [0," << aNt << ") !";
-          throw INTERP_KERNEL::Exception(oss.str().c_str());
-        }
-    }
-}
-
-/*!
- * Copy some tuples from another DataArrayDouble (\a aBase) into contiguous tuples
- * of \a this array. Textual data is not copied. Both arrays must have equal number of
- * components.
- * The tuples to assign to are defined by index of the first tuple, and
- * their number is defined by \a tuplesSelec->getNumberOfTuples().
- * The tuples to copy are defined by values of a DataArrayInt.
- * All components of selected tuples are copied.
- *  \param [in] tupleIdStart - index of the first tuple of \a this array to assign
- *              values to.
- *  \param [in] aBase - the array to copy values from.
- *  \param [in] tuplesSelec - the array specifying tuples of \a a to copy.
- *  \throw If \a this is not allocated.
- *  \throw If \a aBase is NULL.
- *  \throw If \a aBase is not allocated.
- *  \throw If \a tuplesSelec is NULL.
- *  \throw If \a tuplesSelec is not allocated.
- *  \throw If <em>this->getNumberOfComponents() != aBase->getNumberOfComponents()</em>.
- *  \throw If \a tuplesSelec->getNumberOfComponents() != 1.
- *  \throw If <em>tupleIdStart + tuplesSelec->getNumberOfTuples() > this->getNumberOfTuples().</em>
- *  \throw If any tuple index given by \a tuplesSelec is out of a valid range for 
- *         \a aBase array.
- */
-void DataArrayDouble::setContigPartOfSelectedValues(int tupleIdStart, const DataArray *aBase, const DataArrayInt *tuplesSelec)
-{
-  if(!aBase || !tuplesSelec)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::setContigPartOfSelectedValues : input DataArray is NULL !");
-  const DataArrayDouble *a=dynamic_cast<const DataArrayDouble *>(aBase);
-  if(!a)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::setContigPartOfSelectedValues : input DataArray aBase is not a DataArrayDouble !");
-  checkAllocated();
-  a->checkAllocated();
-  tuplesSelec->checkAllocated();
-  int nbOfComp=getNumberOfComponents();
-  if(nbOfComp!=a->getNumberOfComponents())
-    throw INTERP_KERNEL::Exception("DataArrayDouble::setContigPartOfSelectedValues : This and a do not have the same number of components !");
-  if(tuplesSelec->getNumberOfComponents()!=1)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::setContigPartOfSelectedValues : Expecting to have a tuple selector DataArrayInt instance with exactly 1 component !");
-  int thisNt=getNumberOfTuples();
-  int aNt=a->getNumberOfTuples();
-  int nbOfTupleToWrite=tuplesSelec->getNumberOfTuples();
-  double *valsToSet=getPointer()+tupleIdStart*nbOfComp;
-  if(tupleIdStart+nbOfTupleToWrite>thisNt)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::setContigPartOfSelectedValues : invalid number range of values to write !");
-  const double *valsSrc=a->getConstPointer();
-  for(const int *tuple=tuplesSelec->begin();tuple!=tuplesSelec->end();tuple++,valsToSet+=nbOfComp)
-    {
-      if(*tuple>=0 && *tuple<aNt)
-        {
-          std::copy(valsSrc+nbOfComp*(*tuple),valsSrc+nbOfComp*(*tuple+1),valsToSet);
-        }
-      else
-        {
-          std::ostringstream oss; oss << "DataArrayDouble::setContigPartOfSelectedValues : Tuple #" << std::distance(tuplesSelec->begin(),tuple);
-          oss << " of 'tuplesSelec' request of tuple id #" << *tuple << " in 'a' ! It should be in [0," << aNt << ") !";
-          throw INTERP_KERNEL::Exception(oss.str().c_str());
-        }
-    }
-}
+  }
 
-/*!
- * Copy some tuples from another DataArrayDouble (\a aBase) into contiguous tuples
- * of \a this array. Textual data is not copied. Both arrays must have equal number of
- * components.
- * The tuples to copy are defined by three values similar to parameters of
- * the Python function \c range(\c start,\c stop,\c step).
- * The tuples to assign to are defined by index of the first tuple, and
- * their number is defined by number of tuples to copy.
- * All components of selected tuples are copied.
- *  \param [in] tupleIdStart - index of the first tuple of \a this array to assign
- *              values to.
- *  \param [in] aBase - the array to copy values from.
- *  \param [in] bg - index of the first tuple to copy of the array \a aBase.
- *  \param [in] end2 - index of the tuple of \a aBase before which the tuples to copy
- *              are located.
- *  \param [in] step - index increment to get index of the next tuple to copy.
- *  \throw If \a this is not allocated.
- *  \throw If \a aBase is NULL.
- *  \throw If \a aBase is not allocated.
- *  \throw If <em>this->getNumberOfComponents() != aBase->getNumberOfComponents()</em>.
- *  \throw If <em>tupleIdStart + len(range(bg,end2,step)) > this->getNumberOfTuples().</em>
- *  \throw If parameters specifying tuples to copy, do not give a
- *            non-empty range of increasing indices or indices are out of a valid range
- *            for the array \a aBase.
- */
-void DataArrayDouble::setContigPartOfSelectedValuesSlice(int tupleIdStart, const DataArray *aBase, int bg, int end2, int step)
-{
-  if(!aBase)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::setContigPartOfSelectedValuesSlice : input DataArray is NULL !");
-  const DataArrayDouble *a=dynamic_cast<const DataArrayDouble *>(aBase);
-  if(!a)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::setContigPartOfSelectedValuesSlice : input DataArray aBase is not a DataArrayDouble !");
-  checkAllocated();
-  a->checkAllocated();
-  int nbOfComp=getNumberOfComponents();
-  const char msg[]="DataArrayDouble::setContigPartOfSelectedValuesSlice";
-  int nbOfTupleToWrite=DataArray::GetNumberOfItemGivenBES(bg,end2,step,msg);
-  if(nbOfComp!=a->getNumberOfComponents())
-    throw INTERP_KERNEL::Exception("DataArrayDouble::setContigPartOfSelectedValuesSlice : This and a do not have the same number of components !");
-  int thisNt=getNumberOfTuples();
-  int aNt=a->getNumberOfTuples();
-  double *valsToSet=getPointer()+tupleIdStart*nbOfComp;
-  if(tupleIdStart+nbOfTupleToWrite>thisNt)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::setContigPartOfSelectedValuesSlice : invalid number range of values to write !");
-  if(end2>aNt)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::setContigPartOfSelectedValuesSlice : invalid range of values to read !");
-  const double *valsSrc=a->getConstPointer()+bg*nbOfComp;
-  for(int i=0;i<nbOfTupleToWrite;i++,valsToSet+=nbOfComp,valsSrc+=step*nbOfComp)
-    {
-      std::copy(valsSrc,valsSrc+nbOfComp,valsToSet);
-    }
-}
-
-/*!
- * Returns a value located at specified tuple and component.
- * This method is equivalent to DataArrayDouble::getIJ() except that validity of
- * parameters is checked. So this method is safe but expensive if used to go through
- * all values of \a this.
- *  \param [in] tupleId - index of tuple of interest.
- *  \param [in] compoId - index of component of interest.
- *  \return double - value located by \a tupleId and \a compoId.
- *  \throw If \a this is not allocated.
- *  \throw If condition <em>( 0 <= tupleId < this->getNumberOfTuples() )</em> is violated.
- *  \throw If condition <em>( 0 <= compoId < this->getNumberOfComponents() )</em> is violated.
- */
-double DataArrayDouble::getIJSafe(int tupleId, int compoId) const
-{
-  checkAllocated();
-  if(tupleId<0 || tupleId>=getNumberOfTuples())
-    {
-      std::ostringstream oss; oss << "DataArrayDouble::getIJSafe : request for tupleId " << tupleId << " should be in [0," << getNumberOfTuples() << ") !";
-      throw INTERP_KERNEL::Exception(oss.str().c_str());
-    }
-  if(compoId<0 || compoId>=getNumberOfComponents())
-    {
-      std::ostringstream oss; oss << "DataArrayDouble::getIJSafe : request for compoId " << compoId << " should be in [0," << getNumberOfComponents() << ") !";
-      throw INTERP_KERNEL::Exception(oss.str().c_str());
-    }
-  return _mem[tupleId*_info_on_compo.size()+compoId];
+  return ret.retn();
 }
 
 /*!
- * Returns the first value of \a this. 
- *  \return double - the last value of \a this array.
+ * Returns a copy of \a this array by excluding coincident tuples. Each tuple is
+ * considered as coordinates of a point in getNumberOfComponents()-dimensional
+ * space. The distance between tuples is computed using norm2. If several tuples are
+ * not far each from other than \a prec, only one of them remains in the result
+ * array. The order of tuples in the result array is same as in \a this one except
+ * that coincident tuples are excluded.
+ *  \param [in] prec - minimal absolute distance between two tuples at which they are
+ *              considered not coincident.
+ *  \param [in] limitTupleId - limit tuple id. If all tuples within a group of coincident
+ *              tuples have id strictly lower than \a limitTupleId then they are not excluded.
+ *  \return DataArrayDouble * - the new instance of DataArrayDouble that the caller
+ *          is to delete using decrRef() as it is no more needed.
  *  \throw If \a this is not allocated.
- *  \throw If \a this->getNumberOfComponents() != 1.
- *  \throw If \a this->getNumberOfTuples() < 1.
+ *  \throw If the number of components is not in [1,2,3,4].
+ *
+ *  \if ENABLE_EXAMPLES
+ *  \ref py_mcdataarraydouble_getdifferentvalues "Here is a Python example".
+ *  \endif
  */
-double DataArrayDouble::front() const
+DataArrayDouble *DataArrayDouble::getDifferentValues(double prec, int limitTupleId) const
 {
   checkAllocated();
-  if(getNumberOfComponents()!=1)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::front : number of components not equal to one !");
-  int nbOfTuples=getNumberOfTuples();
-  if(nbOfTuples<1)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::front : number of tuples must be >= 1 !");
-  return *(getConstPointer());
+  DataArrayInt *c0=0,*cI0=0;
+  findCommonTuples(prec,limitTupleId,c0,cI0);
+  MCAuto<DataArrayInt> c(c0),cI(cI0);
+  int newNbOfTuples=-1;
+  MCAuto<DataArrayInt> o2n=DataArrayInt::ConvertIndexArrayToO2N(getNumberOfTuples(),c0->begin(),cI0->begin(),cI0->end(),newNbOfTuples);
+  return renumberAndReduce(o2n->getConstPointer(),newNbOfTuples);
 }
 
 /*!
- * Returns the last value of \a this. 
- *  \return double - the last value of \a this array.
- *  \throw If \a this is not allocated.
- *  \throw If \a this->getNumberOfComponents() != 1.
- *  \throw If \a this->getNumberOfTuples() < 1.
+ * Copy all components in a specified order from another DataArrayDouble.
+ * Both numerical and textual data is copied. The number of tuples in \a this and
+ * the other array can be different.
+ *  \param [in] a - the array to copy data from.
+ *  \param [in] compoIds - sequence of zero based indices of components, data of which is
+ *              to be copied.
+ *  \throw If \a a is NULL.
+ *  \throw If \a compoIds.size() != \a a->getNumberOfComponents().
+ *  \throw If \a compoIds[i] < 0 or \a compoIds[i] > \a this->getNumberOfComponents().
+ *
+ *  \if ENABLE_EXAMPLES
+ *  \ref py_mcdataarraydouble_setselectedcomponents "Here is a Python example".
+ *  \endif
  */
-double DataArrayDouble::back() const
+void DataArrayDouble::setSelectedComponents(const DataArrayDouble *a, const std::vector<int>& compoIds)
 {
+  if(!a)
+    throw INTERP_KERNEL::Exception("DataArrayDouble::setSelectedComponents : input DataArrayDouble is NULL !");
   checkAllocated();
-  if(getNumberOfComponents()!=1)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::back : number of components not equal to one !");
-  int nbOfTuples=getNumberOfTuples();
-  if(nbOfTuples<1)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::back : number of tuples must be >= 1 !");
-  return *(getConstPointer()+nbOfTuples-1);
+  copyPartOfStringInfoFrom2(compoIds,*a);
+  std::size_t partOfCompoSz=compoIds.size();
+  int nbOfCompo=getNumberOfComponents();
+  int nbOfTuples=std::min(getNumberOfTuples(),a->getNumberOfTuples());
+  const double *ac=a->getConstPointer();
+  double *nc=getPointer();
+  for(int i=0;i<nbOfTuples;i++)
+    for(std::size_t j=0;j<partOfCompoSz;j++,ac++)
+      nc[nbOfCompo*i+compoIds[j]]=*ac;
 }
 
 void DataArrayDouble::SetArrayIn(DataArrayDouble *newArray, DataArrayDouble* &arrayToSet)
@@ -3035,32 +1588,6 @@ void DataArrayDouble::SetArrayIn(DataArrayDouble *newArray, DataArrayDouble* &ar
     }
 }
 
-/*!
- * Sets a C array to be used as raw data of \a this. The previously set info
- *  of components is retained and re-sized. 
- * For more info see \ref MEDCouplingArraySteps1.
- *  \param [in] array - the C array to be used as raw data of \a this.
- *  \param [in] ownership - if \a true, \a array will be deallocated at destruction of \a this.
- *  \param [in] type - specifies how to deallocate \a array. If \a type == MEDCoupling::CPP_DEALLOC,
- *                     \c delete [] \c array; will be called. If \a type == MEDCoupling::C_DEALLOC,
- *                     \c free(\c array ) will be called.
- *  \param [in] nbOfTuple - new number of tuples in \a this.
- *  \param [in] nbOfCompo - new number of components in \a this.
- */
-void DataArrayDouble::useArray(const double *array, bool ownership, DeallocType type, int nbOfTuple, int nbOfCompo)
-{
-  _info_on_compo.resize(nbOfCompo);
-  _mem.useArray(array,ownership,type,(std::size_t)nbOfTuple*nbOfCompo);
-  declareAsNew();
-}
-
-void DataArrayDouble::useExternalArrayWithRWAccess(const double *array, int nbOfTuple, int nbOfCompo)
-{
-  _info_on_compo.resize(nbOfCompo);
-  _mem.useExternalArrayWithRWAccess(array,(std::size_t)nbOfTuple*nbOfCompo);
-  declareAsNew();
-}
-
 void DataArrayDouble::aggregate(const DataArrayDouble *other)
 {
   if(!other)
@@ -3231,40 +1758,6 @@ void DataArrayDouble::recenterForMaxPrecision(double eps)
     }
 }
 
-/*!
- * Returns the maximal value and its location within \a this one-dimensional array.
- *  \param [out] tupleId - index of the tuple holding the maximal value.
- *  \return double - the maximal value among all values of \a this array.
- *  \throw If \a this->getNumberOfComponents() != 1
- *  \throw If \a this->getNumberOfTuples() < 1
- */
-double DataArrayDouble::getMaxValue(int& tupleId) const
-{
-  checkAllocated();
-  if(getNumberOfComponents()!=1)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::getMaxValue : must be applied on DataArrayDouble with only one component, you can call 'rearrange' method before or call 'getMaxValueInArray' method !");
-  int nbOfTuples=getNumberOfTuples();
-  if(nbOfTuples<=0)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::getMaxValue : array exists but number of tuples must be > 0 !");
-  const double *vals=getConstPointer();
-  const double *loc=std::max_element(vals,vals+nbOfTuples);
-  tupleId=(int)std::distance(vals,loc);
-  return *loc;
-}
-
-/*!
- * Returns the maximal value within \a this array that is allowed to have more than
- *  one component.
- *  \return double - the maximal value among all values of \a this array.
- *  \throw If \a this is not allocated.
- */
-double DataArrayDouble::getMaxValueInArray() const
-{
-  checkAllocated();
-  const double *loc=std::max_element(begin(),end());
-  return *loc;
-}
-
 /*!
  * Returns the maximal value and all its locations within \a this one-dimensional array.
  *  \param [out] tupleIds - a new instance of DataArrayInt containg indices of
@@ -3283,40 +1776,6 @@ double DataArrayDouble::getMaxValue2(DataArrayInt*& tupleIds) const
   return ret;
 }
 
-/*!
- * Returns the minimal value and its location within \a this one-dimensional array.
- *  \param [out] tupleId - index of the tuple holding the minimal value.
- *  \return double - the minimal value among all values of \a this array.
- *  \throw If \a this->getNumberOfComponents() != 1
- *  \throw If \a this->getNumberOfTuples() < 1
- */
-double DataArrayDouble::getMinValue(int& tupleId) const
-{
-  checkAllocated();
-  if(getNumberOfComponents()!=1)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::getMinValue : must be applied on DataArrayDouble with only one component, you can call 'rearrange' method before call 'getMinValueInArray' method !");
-  int nbOfTuples=getNumberOfTuples();
-  if(nbOfTuples<=0)
-    throw INTERP_KERNEL::Exception("DataArrayDouble::getMinValue : array exists but number of tuples must be > 0 !");
-  const double *vals=getConstPointer();
-  const double *loc=std::min_element(vals,vals+nbOfTuples);
-  tupleId=(int)std::distance(vals,loc);
-  return *loc;
-}
-
-/*!
- * Returns the minimal value within \a this array that is allowed to have more than
- *  one component.
- *  \return double - the minimal value among all values of \a this array.
- *  \throw If \a this is not allocated.
- */
-double DataArrayDouble::getMinValueInArray() const
-{
-  checkAllocated();
-  const double *loc=std::min_element(begin(),end());
-  return *loc;
-}
-
 /*!
  * Returns the minimal value and all its locations within \a this one-dimensional array.
  *  \param [out] tupleIds - a new instance of DataArrayInt containg indices of
@@ -4757,6 +3216,21 @@ void DataArrayDouble::applyFuncFast64(const std::string& func)
   declareAsNew();
 }
 
+/*!
+ * \return a new object that is the result of the symmetry along 3D plane defined by its normal vector \a normalVector and a point \a point.
+ */
+MCAuto<DataArrayDouble> DataArrayDouble::symmetry3DPlane(const double point[3], const double normalVector[3]) const
+{
+  checkAllocated();
+  if(getNumberOfComponents()!=3)
+    throw INTERP_KERNEL::Exception("DataArrayDouble::symmetry3DPlane : this is excepted to have 3 components !");
+  int nbTuples(getNumberOfTuples());
+  MCAuto<DataArrayDouble> ret(DataArrayDouble::New());
+  ret->alloc(nbTuples,3);
+  Symmetry3DPlane(point,normalVector,nbTuples,begin(),ret->getPointer());
+  return ret;
+}
+
 DataArrayDoubleIterator *DataArrayDouble::iterator()
 {
   return new DataArrayDoubleIterator(this);
@@ -5896,6 +4370,112 @@ void DataArrayDouble::finishUnserialization(const std::vector<int>& tinyInfoI, c
     }
 }
 
+/*!
+ * Low static method that operates 3D rotation of 'nbNodes' 3D nodes whose coordinates are arranged in \a coordsIn
+ * around an axe ( \a center, \a vect) and with angle \a angle.
+ */
+void DataArrayDouble::Rotate3DAlg(const double *center, const double *vect, double angle, int nbNodes, const double *coordsIn, double *coordsOut)
+{
+  if(!center || !vect)
+    throw INTERP_KERNEL::Exception("DataArrayDouble::Rotate3DAlg : null vector in input !");
+  double sina(sin(angle));
+  double cosa(cos(angle));
+  double vectorNorm[3];
+  double matrix[9];
+  double matrixTmp[9];
+  double norm(sqrt(vect[0]*vect[0]+vect[1]*vect[1]+vect[2]*vect[2]));
+  if(norm<std::numeric_limits<double>::min())
+    throw INTERP_KERNEL::Exception("DataArrayDouble::Rotate3DAlg : magnitude of input vector is too close of 0. !");
+  std::transform(vect,vect+3,vectorNorm,std::bind2nd(std::multiplies<double>(),1/norm));
+  //rotation matrix computation
+  matrix[0]=cosa; matrix[1]=0.; matrix[2]=0.; matrix[3]=0.; matrix[4]=cosa; matrix[5]=0.; matrix[6]=0.; matrix[7]=0.; matrix[8]=cosa;
+  matrixTmp[0]=vectorNorm[0]*vectorNorm[0]; matrixTmp[1]=vectorNorm[0]*vectorNorm[1]; matrixTmp[2]=vectorNorm[0]*vectorNorm[2];
+  matrixTmp[3]=vectorNorm[1]*vectorNorm[0]; matrixTmp[4]=vectorNorm[1]*vectorNorm[1]; matrixTmp[5]=vectorNorm[1]*vectorNorm[2];
+  matrixTmp[6]=vectorNorm[2]*vectorNorm[0]; matrixTmp[7]=vectorNorm[2]*vectorNorm[1]; matrixTmp[8]=vectorNorm[2]*vectorNorm[2];
+  std::transform(matrixTmp,matrixTmp+9,matrixTmp,std::bind2nd(std::multiplies<double>(),1-cosa));
+  std::transform(matrix,matrix+9,matrixTmp,matrix,std::plus<double>());
+  matrixTmp[0]=0.; matrixTmp[1]=-vectorNorm[2]; matrixTmp[2]=vectorNorm[1];
+  matrixTmp[3]=vectorNorm[2]; matrixTmp[4]=0.; matrixTmp[5]=-vectorNorm[0];
+  matrixTmp[6]=-vectorNorm[1]; matrixTmp[7]=vectorNorm[0]; matrixTmp[8]=0.;
+  std::transform(matrixTmp,matrixTmp+9,matrixTmp,std::bind2nd(std::multiplies<double>(),sina));
+  std::transform(matrix,matrix+9,matrixTmp,matrix,std::plus<double>());
+  //rotation matrix computed.
+  double tmp[3];
+  for(int i=0; i<nbNodes; i++)
+    {
+      std::transform(coordsIn+i*3,coordsIn+(i+1)*3,center,tmp,std::minus<double>());
+      coordsOut[i*3]=matrix[0]*tmp[0]+matrix[1]*tmp[1]+matrix[2]*tmp[2]+center[0];
+      coordsOut[i*3+1]=matrix[3]*tmp[0]+matrix[4]*tmp[1]+matrix[5]*tmp[2]+center[1];
+      coordsOut[i*3+2]=matrix[6]*tmp[0]+matrix[7]*tmp[1]+matrix[8]*tmp[2]+center[2];
+    }
+}
+
+void DataArrayDouble::Symmetry3DPlane(const double point[3], const double normalVector[3], int nbNodes, const double *coordsIn, double *coordsOut)
+{
+  double matrix[9],matrix2[9],matrix3[9];
+  double vect[3],crossVect[3];
+  INTERP_KERNEL::orthogonalVect3(normalVector,vect);
+  crossVect[0]=normalVector[1]*vect[2]-normalVector[2]*vect[1];
+  crossVect[1]=normalVector[2]*vect[0]-normalVector[0]*vect[2];
+  crossVect[2]=normalVector[0]*vect[1]-normalVector[1]*vect[0];
+  double nv(INTERP_KERNEL::norm<3>(vect)),ni(INTERP_KERNEL::norm<3>(normalVector)),nc(INTERP_KERNEL::norm<3>(crossVect));
+  matrix[0]=vect[0]/nv; matrix[1]=crossVect[0]/nc; matrix[2]=-normalVector[0]/ni;
+  matrix[3]=vect[1]/nv; matrix[4]=crossVect[1]/nc; matrix[5]=-normalVector[1]/ni;
+  matrix[6]=vect[2]/nv; matrix[7]=crossVect[2]/nc; matrix[8]=-normalVector[2]/ni;
+  matrix2[0]=vect[0]/nv; matrix2[1]=vect[1]/nv; matrix2[2]=vect[2]/nv;
+  matrix2[3]=crossVect[0]/nc; matrix2[4]=crossVect[1]/nc; matrix2[5]=crossVect[2]/nc;
+  matrix2[6]=normalVector[0]/ni; matrix2[7]=normalVector[1]/ni; matrix2[8]=normalVector[2]/ni;
+  for(int i=0;i<3;i++)
+    for(int j=0;j<3;j++)
+      {
+        double val(0.);
+        for(int k=0;k<3;k++)
+          val+=matrix[3*i+k]*matrix2[3*k+j];
+        matrix3[3*i+j]=val;
+      }
+  //rotation matrix computed.
+  double tmp[3];
+  for(int i=0; i<nbNodes; i++)
+    {
+      std::transform(coordsIn+i*3,coordsIn+(i+1)*3,point,tmp,std::minus<double>());
+      coordsOut[i*3]=matrix3[0]*tmp[0]+matrix3[1]*tmp[1]+matrix3[2]*tmp[2]+point[0];
+      coordsOut[i*3+1]=matrix3[3]*tmp[0]+matrix3[4]*tmp[1]+matrix3[5]*tmp[2]+point[1];
+      coordsOut[i*3+2]=matrix3[6]*tmp[0]+matrix3[7]*tmp[1]+matrix3[8]*tmp[2]+point[2];
+    }
+}
+
+void DataArrayDouble::GiveBaseForPlane(const double normalVector[3], double baseOfPlane[9])
+{
+  double vect[3],crossVect[3];
+  INTERP_KERNEL::orthogonalVect3(normalVector,vect);
+  crossVect[0]=normalVector[1]*vect[2]-normalVector[2]*vect[1];
+  crossVect[1]=normalVector[2]*vect[0]-normalVector[0]*vect[2];
+  crossVect[2]=normalVector[0]*vect[1]-normalVector[1]*vect[0];
+  double nv(INTERP_KERNEL::norm<3>(vect)),ni(INTERP_KERNEL::norm<3>(normalVector)),nc(INTERP_KERNEL::norm<3>(crossVect));
+  baseOfPlane[0]=vect[0]/nv; baseOfPlane[1]=vect[1]/nv; baseOfPlane[2]=vect[2]/nv;
+  baseOfPlane[3]=crossVect[0]/nc; baseOfPlane[4]=crossVect[1]/nc; baseOfPlane[5]=crossVect[2]/nc;
+  baseOfPlane[6]=normalVector[0]/ni; baseOfPlane[7]=normalVector[1]/ni; baseOfPlane[8]=normalVector[2]/ni;
+}
+
+/*!
+ * Low static method that operates 3D rotation of \a nbNodes 3D nodes whose coordinates are arranged in \a coords
+ * around the center point \a center and with angle \a angle.
+ */
+void DataArrayDouble::Rotate2DAlg(const double *center, double angle, int nbNodes, const double *coordsIn, double *coordsOut)
+{
+  double cosa=cos(angle);
+  double sina=sin(angle);
+  double matrix[4];
+  matrix[0]=cosa; matrix[1]=-sina; matrix[2]=sina; matrix[3]=cosa;
+  double tmp[2];
+  for(int i=0; i<nbNodes; i++)
+    {
+      std::transform(coordsIn+i*2,coordsIn+(i+1)*2,center,tmp,std::minus<double>());
+      coordsOut[i*2]=matrix[0]*tmp[0]+matrix[1]*tmp[1]+center[0];
+      coordsOut[i*2+1]=matrix[2]*tmp[0]+matrix[3]*tmp[1]+center[1];
+    }
+}
+
 DataArrayDoubleIterator::DataArrayDoubleIterator(DataArrayDouble *da):_da(da),_tuple_id(0),_nb_comp(0),_nb_tuple(0)
 {
   if(_da)
@@ -5981,43 +4561,6 @@ DataArrayInt *DataArrayInt::New()
   return new DataArrayInt;
 }
 
-/*!
- * Checks if raw data is allocated. Read more on the raw data
- * in \ref MEDCouplingArrayBasicsTuplesAndCompo "DataArrays infos" for more information.
- *  \return bool - \a true if the raw data is allocated, \a false else.
- */
-bool DataArrayInt::isAllocated() const
-{
-  return getConstPointer()!=0;
-}
-
-/*!
- * Checks if raw data is allocated and throws an exception if it is not the case.
- *  \throw If the raw data is not allocated.
- */
-void DataArrayInt::checkAllocated() const
-{
-  if(!isAllocated())
-    throw INTERP_KERNEL::Exception("DataArrayInt::checkAllocated : Array is defined but not allocated ! Call alloc or setValues method first !");
-}
-
-/*!
- * This method desallocated \a this without modification of informations relative to the components.
- * After call of this method, DataArrayInt::isAllocated will return false.
- * If \a this is already not allocated, \a this is let unchanged.
- */
-void DataArrayInt::desallocate()
-{
-  _mem.destroy();
-}
-
-std::size_t DataArrayInt::getHeapMemorySizeWithoutChildren() const
-{
-  std::size_t sz(_mem.getNbOfElemAllocated());
-  sz*=sizeof(int);
-  return DataArray::getHeapMemorySizeWithoutChildren()+sz;
-}
-
 /*!
  * Returns the only one value in \a this, if and only if number of elements
  * (nb of tuples * nb of components) is equal to 1, and that \a this is allocated.
@@ -6060,17 +4603,6 @@ int DataArrayInt::getHashCode() const
   return ret+ret0;
 }
 
-/*!
- * Checks the number of tuples.
- *  \return bool - \a true if getNumberOfTuples() == 0, \a false else.
- *  \throw If \a this is not allocated.
- */
-bool DataArrayInt::empty() const
-{
-  checkAllocated();
-  return getNumberOfTuples()==0;
-}
-
 /*!
  * Returns a full copy of \a this. For more info on copying data arrays see
  * \ref MEDCouplingArrayBasicsCopyDeep.
@@ -6099,154 +4631,6 @@ DataArrayInt *DataArrayInt::performCopyOrIncrRef(bool dCpy) const
     }
 }
 
-/*!
- * Copies all the data from another DataArrayInt. For more info see
- * \ref MEDCouplingArrayBasicsCopyDeepAssign.
- *  \param [in] other - another instance of DataArrayInt to copy data from.
- *  \throw If the \a other is not allocated.
- */
-void DataArrayInt::deepCopyFrom(const DataArrayInt& other)
-{
-  other.checkAllocated();
-  int nbOfTuples=other.getNumberOfTuples();
-  int nbOfComp=other.getNumberOfComponents();
-  allocIfNecessary(nbOfTuples,nbOfComp);
-  std::size_t nbOfElems=(std::size_t)nbOfTuples*nbOfComp;
-  int *pt=getPointer();
-  const int *ptI=other.getConstPointer();
-  for(std::size_t i=0;i<nbOfElems;i++)
-    pt[i]=ptI[i];
-  copyStringInfoFrom(other);
-}
-
-/*!
- * This method reserve nbOfElems elements in memory ( nbOfElems*4 bytes ) \b without impacting the number of tuples in \a this.
- * If \a this has already been allocated, this method checks that \a this has only one component. If not an INTERP_KERNEL::Exception will be thrown.
- * If \a this has not already been allocated, number of components is set to one.
- * This method allows to reduce number of reallocations on invokation of DataArrayInt::pushBackSilent and DataArrayInt::pushBackValsSilent on \a this.
- * 
- * \sa DataArrayInt::pack, DataArrayInt::pushBackSilent, DataArrayInt::pushBackValsSilent
- */
-void DataArrayInt::reserve(std::size_t nbOfElems)
-{
-  int nbCompo=getNumberOfComponents();
-  if(nbCompo==1)
-    {
-      _mem.reserve(nbOfElems);
-    }
-  else if(nbCompo==0)
-    {
-      _mem.reserve(nbOfElems);
-      _info_on_compo.resize(1);
-    }
-  else
-    throw INTERP_KERNEL::Exception("DataArrayInt::reserve : not available for DataArrayInt with number of components different than 1 !");
-}
-
-/*!
- * This method adds at the end of \a this the single value \a val. This method do \b not update its time label to avoid useless incrementation
- * of counter. So the caller is expected to call TimeLabel::declareAsNew on \a this at the end of the push session.
- *
- * \param [in] val the value to be added in \a this
- * \throw If \a this has already been allocated with number of components different from one.
- * \sa DataArrayInt::pushBackValsSilent
- */
-void DataArrayInt::pushBackSilent(int val)
-{
-  int nbCompo=getNumberOfComponents();
-  if(nbCompo==1)
-    _mem.pushBack(val);
-  else if(nbCompo==0)
-    {
-      _info_on_compo.resize(1);
-      _mem.pushBack(val);
-    }
-  else
-    throw INTERP_KERNEL::Exception("DataArrayInt::pushBackSilent : not available for DataArrayInt with number of components different than 1 !");
-}
-
-/*!
- * This method adds at the end of \a this a serie of values [\c valsBg,\c valsEnd). This method do \b not update its time label to avoid useless incrementation
- * of counter. So the caller is expected to call TimeLabel::declareAsNew on \a this at the end of the push session.
- *
- *  \param [in] valsBg - an array of values to push at the end of \c this.
- *  \param [in] valsEnd - specifies the end of the array \a valsBg, so that
- *              the last value of \a valsBg is \a valsEnd[ -1 ].
- * \throw If \a this has already been allocated with number of components different from one.
- * \sa DataArrayInt::pushBackSilent
- */
-void DataArrayInt::pushBackValsSilent(const int *valsBg, const int *valsEnd)
-{
-  int nbCompo=getNumberOfComponents();
-  if(nbCompo==1)
-    _mem.insertAtTheEnd(valsBg,valsEnd);
-  else if(nbCompo==0)
-    {
-      _info_on_compo.resize(1);
-      _mem.insertAtTheEnd(valsBg,valsEnd);
-    }
-  else
-    throw INTERP_KERNEL::Exception("DataArrayInt::pushBackValsSilent : not available for DataArrayInt with number of components different than 1 !");
-}
-
-/*!
- * This method returns silently ( without updating time label in \a this ) the last value, if any and suppress it.
- * \throw If \a this is already empty.
- * \throw If \a this has number of components different from one.
- */
-int DataArrayInt::popBackSilent()
-{
-  if(getNumberOfComponents()==1)
-    return _mem.popBack();
-  else
-    throw INTERP_KERNEL::Exception("DataArrayInt::popBackSilent : not available for DataArrayInt with number of components different than 1 !");
-}
-
-/*!
- * This method \b do \b not modify content of \a this. It only modify its memory footprint if the allocated memory is to high regarding real data to store.
- *
- * \sa DataArrayInt::getHeapMemorySizeWithoutChildren, DataArrayInt::reserve
- */
-void DataArrayInt::pack() const
-{
-  _mem.pack();
-}
-
-/*!
- * Allocates the raw data in memory. If exactly as same memory as needed already
- * allocated, it is not re-allocated.
- *  \param [in] nbOfTuple - number of tuples of data to allocate.
- *  \param [in] nbOfCompo - number of components of data to allocate.
- *  \throw If \a nbOfTuple < 0 or \a nbOfCompo < 0.
- */
-void DataArrayInt::allocIfNecessary(int nbOfTuple, int nbOfCompo)
-{
-  if(isAllocated())
-    {
-      if(nbOfTuple!=getNumberOfTuples() || nbOfCompo!=getNumberOfComponents())
-        alloc(nbOfTuple,nbOfCompo);
-    }
-  else
-    alloc(nbOfTuple,nbOfCompo);
-}
-
-/*!
- * Allocates the raw data in memory. If the memory was already allocated, then it is
- * freed and re-allocated. See an example of this method use
- * \ref MEDCouplingArraySteps1WC "here".
- *  \param [in] nbOfTuple - number of tuples of data to allocate.
- *  \param [in] nbOfCompo - number of components of data to allocate.
- *  \throw If \a nbOfTuple < 0 or \a nbOfCompo < 0.
- */
-void DataArrayInt::alloc(int nbOfTuple, int nbOfCompo)
-{
-  if(nbOfTuple<0 || nbOfCompo<0)
-    throw INTERP_KERNEL::Exception("DataArrayInt::alloc : request for negative length of data !");
-  _info_on_compo.resize(nbOfCompo);
-  _mem.alloc(nbOfCompo*(std::size_t)nbOfTuple);
-  declareAsNew();
-}
-
 /*!
  * Assign zero to all values in \a this array. To know more on filling arrays see
  * \ref MEDCouplingArrayFill.
@@ -6254,22 +4638,7 @@ void DataArrayInt::alloc(int nbOfTuple, int nbOfCompo)
  */
 void DataArrayInt::fillWithZero()
 {
-  checkAllocated();
-  _mem.fillWithValue(0);
-  declareAsNew();
-}
-
-/*!
- * Assign \a val to all values in \a this array. To know more on filling arrays see
- * \ref MEDCouplingArrayFill.
- *  \param [in] val - the value to fill with.
- *  \throw If \a this is not allocated.
- */
-void DataArrayInt::fillWithValue(int val)
-{
-  checkAllocated();
-  _mem.fillWithValue(val);
-  declareAsNew();
+  fillWithValue(0);
 }
 
 /*!
@@ -6954,21 +5323,6 @@ void DataArrayInt::switchOnTupleNotEqualTo(int val, std::vector<bool>& vec) cons
       vec[i]=true;
 }
 
-/*!
- * Sorts values of the array.
- *  \param [in] asc - \a true means ascending order, \a false, descending.
- *  \throw If \a this is not allocated.
- *  \throw If \a this->getNumberOfComponents() != 1.
- */
-void DataArrayInt::sort(bool asc)
-{
-  checkAllocated();
-  if(getNumberOfComponents()!=1)
-    throw INTERP_KERNEL::Exception("DataArrayInt::sort : only supported with 'this' array with ONE component !");
-  _mem.sort(asc);
-  declareAsNew();
-}
-
 /*!
  * Computes for each tuple the sum of number of components values in the tuple and return it.
  * 
@@ -6991,18 +5345,6 @@ DataArrayInt *DataArrayInt::sumPerTuple() const
   return ret.retn();
 }
 
-/*!
- * Reverse the array values.
- *  \throw If \a this->getNumberOfComponents() < 1.
- *  \throw If \a this is not allocated.
- */
-void DataArrayInt::reverse()
-{
-  checkAllocated();
-  _mem.reverse(getNumberOfComponents());
-  declareAsNew();
-}
-
 /*!
  * Checks that \a this array is consistently **increasing** or **decreasing** in value.
  * If not an exception is thrown.
@@ -7165,32 +5507,6 @@ DataArrayInt *DataArrayInt::buildPermutationArr(const DataArrayInt& other) const
   return ret.retn();
 }
 
-/*!
- * Sets a C array to be used as raw data of \a this. The previously set info
- *  of components is retained and re-sized. 
- * For more info see \ref MEDCouplingArraySteps1.
- *  \param [in] array - the C array to be used as raw data of \a this.
- *  \param [in] ownership - if \a true, \a array will be deallocated at destruction of \a this.
- *  \param [in] type - specifies how to deallocate \a array. If \a type == MEDCoupling::CPP_DEALLOC,
- *                     \c delete [] \c array; will be called. If \a type == MEDCoupling::C_DEALLOC,
- *                     \c free(\c array ) will be called.
- *  \param [in] nbOfTuple - new number of tuples in \a this.
- *  \param [in] nbOfCompo - new number of components in \a this.
- */
-void DataArrayInt::useArray(const int *array, bool ownership,  DeallocType type, int nbOfTuple, int nbOfCompo)
-{
-  _info_on_compo.resize(nbOfCompo);
-  _mem.useArray(array,ownership,type,nbOfTuple*nbOfCompo);
-  declareAsNew();
-}
-
-void DataArrayInt::useExternalArrayWithRWAccess(const int *array, int nbOfTuple, int nbOfCompo)
-{
-  _info_on_compo.resize(nbOfCompo);
-  _mem.useExternalArrayWithRWAccess(array,nbOfTuple*nbOfCompo);
-  declareAsNew();
-}
-
 void DataArrayInt::aggregate(const DataArrayInt *other)
 {
   if(!other)
@@ -7242,323 +5558,6 @@ DataArrayInt *DataArrayInt::toNoInterlace() const
   return ret;
 }
 
-/*!
- * Permutes values of \a this array as required by \a old2New array. The values are
- * permuted so that \c new[ \a old2New[ i ]] = \c old[ i ]. Number of tuples remains
- * the same as in \c this one.
- * If a permutation reduction is needed, subArray() or selectByTupleId() should be used.
- * For more info on renumbering see \ref numbering.
- *  \param [in] old2New - C array of length equal to \a this->getNumberOfTuples()
- *     giving a new position for i-th old value.
- */
-void DataArrayInt::renumberInPlace(const int *old2New)
-{
-  checkAllocated();
-  int nbTuples=getNumberOfTuples();
-  int nbOfCompo=getNumberOfComponents();
-  int *tmp=new int[nbTuples*nbOfCompo];
-  const int *iptr=getConstPointer();
-  for(int i=0;i<nbTuples;i++)
-    {
-      int v=old2New[i];
-      if(v>=0 && v<nbTuples)
-        std::copy(iptr+nbOfCompo*i,iptr+nbOfCompo*(i+1),tmp+nbOfCompo*v);
-      else
-        {
-          std::ostringstream oss; oss << "DataArrayInt::renumberInPlace : At place #" << i << " value is " << v << " ! Should be in [0," << nbTuples << ") !";
-          throw INTERP_KERNEL::Exception(oss.str().c_str());
-        }
-    }
-  std::copy(tmp,tmp+nbTuples*nbOfCompo,getPointer());
-  delete [] tmp;
-  declareAsNew();
-}
-
-/*!
- * Permutes values of \a this array as required by \a new2Old array. The values are
- * permuted so that \c new[ i ] = \c old[ \a new2Old[ i ]]. Number of tuples remains
- * the same as in \c this one.
- * For more info on renumbering see \ref numbering.
- *  \param [in] new2Old - C array of length equal to \a this->getNumberOfTuples()
- *     giving a previous position of i-th new value.
- *  \return DataArrayInt * - the new instance of DataArrayInt that the caller
- *          is to delete using decrRef() as it is no more needed.
- */
-void DataArrayInt::renumberInPlaceR(const int *new2Old)
-{
-  checkAllocated();
-  int nbTuples=getNumberOfTuples();
-  int nbOfCompo=getNumberOfComponents();
-  int *tmp=new int[nbTuples*nbOfCompo];
-  const int *iptr=getConstPointer();
-  for(int i=0;i<nbTuples;i++)
-    {
-      int v=new2Old[i];
-      if(v>=0 && v<nbTuples)
-        std::copy(iptr+nbOfCompo*v,iptr+nbOfCompo*(v+1),tmp+nbOfCompo*i);
-      else
-        {
-          std::ostringstream oss; oss << "DataArrayInt::renumberInPlaceR : At place #" << i << " value is " << v << " ! Should be in [0," << nbTuples << ") !";
-          throw INTERP_KERNEL::Exception(oss.str().c_str());
-        }
-    }
-  std::copy(tmp,tmp+nbTuples*nbOfCompo,getPointer());
-  delete [] tmp;
-  declareAsNew();
-}
-
-/*!
- * Returns a copy of \a this array with values permuted as required by \a old2New array.
- * The values are permuted so that  \c new[ \a old2New[ i ]] = \c old[ i ].
- * Number of tuples in the result array remains the same as in \c this one.
- * If a permutation reduction is needed, renumberAndReduce() should be used.
- * For more info on renumbering see \ref numbering.
- *  \param [in] old2New - C array of length equal to \a this->getNumberOfTuples()
- *          giving a new position for i-th old value.
- *  \return DataArrayInt * - the new instance of DataArrayInt that the caller
- *          is to delete using decrRef() as it is no more needed.
- *  \throw If \a this is not allocated.
- */
-DataArrayInt *DataArrayInt::renumber(const int *old2New) const
-{
-  checkAllocated();
-  int nbTuples=getNumberOfTuples();
-  int nbOfCompo=getNumberOfComponents();
-  MCAuto<DataArrayInt> ret=DataArrayInt::New();
-  ret->alloc(nbTuples,nbOfCompo);
-  ret->copyStringInfoFrom(*this);
-  const int *iptr=getConstPointer();
-  int *optr=ret->getPointer();
-  for(int i=0;i<nbTuples;i++)
-    std::copy(iptr+nbOfCompo*i,iptr+nbOfCompo*(i+1),optr+nbOfCompo*old2New[i]);
-  ret->copyStringInfoFrom(*this);
-  return ret.retn();
-}
-
-/*!
- * Returns a copy of \a this array with values permuted as required by \a new2Old array.
- * The values are permuted so that  \c new[ i ] = \c old[ \a new2Old[ i ]]. Number of
- * tuples in the result array remains the same as in \c this one.
- * If a permutation reduction is needed, subArray() or selectByTupleId() should be used.
- * For more info on renumbering see \ref numbering.
- *  \param [in] new2Old - C array of length equal to \a this->getNumberOfTuples()
- *     giving a previous position of i-th new value.
- *  \return DataArrayInt * - the new instance of DataArrayInt that the caller
- *          is to delete using decrRef() as it is no more needed.
- */
-DataArrayInt *DataArrayInt::renumberR(const int *new2Old) const
-{
-  checkAllocated();
-  int nbTuples=getNumberOfTuples();
-  int nbOfCompo=getNumberOfComponents();
-  MCAuto<DataArrayInt> ret=DataArrayInt::New();
-  ret->alloc(nbTuples,nbOfCompo);
-  ret->copyStringInfoFrom(*this);
-  const int *iptr=getConstPointer();
-  int *optr=ret->getPointer();
-  for(int i=0;i<nbTuples;i++)
-    std::copy(iptr+nbOfCompo*new2Old[i],iptr+nbOfCompo*(new2Old[i]+1),optr+nbOfCompo*i);
-  ret->copyStringInfoFrom(*this);
-  return ret.retn();
-}
-
-/*!
- * Returns a shorten and permuted copy of \a this array. The new DataArrayInt is
- * of size \a newNbOfTuple and it's values are permuted as required by \a old2New array.
- * The values are permuted so that  \c new[ \a old2New[ i ]] = \c old[ i ] for all
- * \a old2New[ i ] >= 0. In other words every i-th tuple in \a this array, for which 
- * \a old2New[ i ] is negative, is missing from the result array.
- * For more info on renumbering see \ref numbering.
- *  \param [in] old2New - C array of length equal to \a this->getNumberOfTuples()
- *     giving a new position for i-th old tuple and giving negative position for
- *     for i-th old tuple that should be omitted.
- *  \return DataArrayInt * - the new instance of DataArrayInt that the caller
- *          is to delete using decrRef() as it is no more needed.
- */
-DataArrayInt *DataArrayInt::renumberAndReduce(const int *old2New, int newNbOfTuple) const
-{
-  checkAllocated();
-  int nbTuples=getNumberOfTuples();
-  int nbOfCompo=getNumberOfComponents();
-  MCAuto<DataArrayInt> ret=DataArrayInt::New();
-  ret->alloc(newNbOfTuple,nbOfCompo);
-  const int *iptr=getConstPointer();
-  int *optr=ret->getPointer();
-  for(int i=0;i<nbTuples;i++)
-    {
-      int w=old2New[i];
-      if(w>=0)
-        std::copy(iptr+i*nbOfCompo,iptr+(i+1)*nbOfCompo,optr+w*nbOfCompo);
-    }
-  ret->copyStringInfoFrom(*this);
-  return ret.retn();
-}
-
-/*!
- * Returns a shorten and permuted copy of \a this array. The new DataArrayInt is
- * of size \a new2OldEnd - \a new2OldBg and it's values are permuted as required by
- * \a new2OldBg array.
- * The values are permuted so that  \c new[ i ] = \c old[ \a new2OldBg[ i ]].
- * This method is equivalent to renumberAndReduce() except that convention in input is
- * \c new2old and \b not \c old2new.
- * For more info on renumbering see \ref numbering.
- *  \param [in] new2OldBg - pointer to the beginning of a permutation array that gives a
- *              tuple index in \a this array to fill the i-th tuple in the new array.
- *  \param [in] new2OldEnd - specifies the end of the permutation array that starts at
- *              \a new2OldBg, so that pointer to a tuple index (\a pi) varies as this:
- *              \a new2OldBg <= \a pi < \a new2OldEnd.
- *  \return DataArrayInt * - the new instance of DataArrayInt that the caller
- *          is to delete using decrRef() as it is no more needed.
- */
-DataArrayInt *DataArrayInt::selectByTupleId(const int *new2OldBg, const int *new2OldEnd) const
-{
-  checkAllocated();
-  MCAuto<DataArrayInt> ret=DataArrayInt::New();
-  int nbComp=getNumberOfComponents();
-  ret->alloc((int)std::distance(new2OldBg,new2OldEnd),nbComp);
-  ret->copyStringInfoFrom(*this);
-  int *pt=ret->getPointer();
-  const int *srcPt=getConstPointer();
-  int i=0;
-  for(const int *w=new2OldBg;w!=new2OldEnd;w++,i++)
-    std::copy(srcPt+(*w)*nbComp,srcPt+((*w)+1)*nbComp,pt+i*nbComp);
-  ret->copyStringInfoFrom(*this);
-  return ret.retn();
-}
-
-/*!
- * Returns a shorten and permuted copy of \a this array. The new DataArrayInt is
- * of size \a new2OldEnd - \a new2OldBg and it's values are permuted as required by
- * \a new2OldBg array.
- * The values are permuted so that  \c new[ i ] = \c old[ \a new2OldBg[ i ]].
- * This method is equivalent to renumberAndReduce() except that convention in input is
- * \c new2old and \b not \c old2new.
- * This method is equivalent to selectByTupleId() except that it prevents coping data
- * from behind the end of \a this array.
- * For more info on renumbering see \ref numbering.
- *  \param [in] new2OldBg - pointer to the beginning of a permutation array that gives a
- *              tuple index in \a this array to fill the i-th tuple in the new array.
- *  \param [in] new2OldEnd - specifies the end of the permutation array that starts at
- *              \a new2OldBg, so that pointer to a tuple index (\a pi) varies as this:
- *              \a new2OldBg <= \a pi < \a new2OldEnd.
- *  \return DataArrayInt * - the new instance of DataArrayInt that the caller
- *          is to delete using decrRef() as it is no more needed.
- *  \throw If \a new2OldEnd - \a new2OldBg > \a this->getNumberOfTuples().
- */
-DataArrayInt *DataArrayInt::selectByTupleIdSafe(const int *new2OldBg, const int *new2OldEnd) const
-{
-  checkAllocated();
-  MCAuto<DataArrayInt> ret=DataArrayInt::New();
-  int nbComp=getNumberOfComponents();
-  int oldNbOfTuples=getNumberOfTuples();
-  ret->alloc((int)std::distance(new2OldBg,new2OldEnd),nbComp);
-  ret->copyStringInfoFrom(*this);
-  int *pt=ret->getPointer();
-  const int *srcPt=getConstPointer();
-  int i=0;
-  for(const int *w=new2OldBg;w!=new2OldEnd;w++,i++)
-    if(*w>=0 && *w<oldNbOfTuples)
-      std::copy(srcPt+(*w)*nbComp,srcPt+((*w)+1)*nbComp,pt+i*nbComp);
-    else
-      throw INTERP_KERNEL::Exception("DataArrayInt::selectByTupleIdSafe : some ids has been detected to be out of [0,this->getNumberOfTuples) !");
-  ret->copyStringInfoFrom(*this);
-  return ret.retn();
-}
-
-/*!
- * Returns a shorten copy of \a this array. The new DataArrayInt contains every
- * (\a bg + \c i * \a step)-th tuple of \a this array located before the \a end2-th
- * tuple. Indices of the selected tuples are the same as ones returned by the Python
- * command \c range( \a bg, \a end2, \a step ).
- * This method is equivalent to selectByTupleIdSafe() except that the input array is
- * not constructed explicitly.
- * For more info on renumbering see \ref numbering.
- *  \param [in] bg - index of the first tuple to copy from \a this array.
- *  \param [in] end2 - index of the tuple before which the tuples to copy are located.
- *  \param [in] step - index increment to get index of the next tuple to copy.
- *  \return DataArrayInt * - the new instance of DataArrayInt that the caller
- *          is to delete using decrRef() as it is no more needed.
- *  \sa DataArrayInt::subArray.
- */
-DataArrayInt *DataArrayInt::selectByTupleIdSafeSlice(int bg, int end2, int step) const
-{
-  checkAllocated();
-  MCAuto<DataArrayInt> ret=DataArrayInt::New();
-  int nbComp=getNumberOfComponents();
-  int newNbOfTuples=GetNumberOfItemGivenBESRelative(bg,end2,step,"DataArrayInt::selectByTupleIdSafeSlice : ");
-  ret->alloc(newNbOfTuples,nbComp);
-  int *pt=ret->getPointer();
-  const int *srcPt=getConstPointer()+bg*nbComp;
-  for(int i=0;i<newNbOfTuples;i++,srcPt+=step*nbComp)
-    std::copy(srcPt,srcPt+nbComp,pt+i*nbComp);
-  ret->copyStringInfoFrom(*this);
-  return ret.retn();
-}
-
-/*!
- * Returns a shorten copy of \a this array. The new DataArrayInt contains ranges
- * of tuples specified by \a ranges parameter.
- * For more info on renumbering see \ref numbering.
- *  \param [in] ranges - std::vector of std::pair's each of which defines a range
- *              of tuples in [\c begin,\c end) format.
- *  \return DataArrayInt * - the new instance of DataArrayInt that the caller
- *          is to delete using decrRef() as it is no more needed.
- *  \throw If \a end < \a begin.
- *  \throw If \a end > \a this->getNumberOfTuples().
- *  \throw If \a this is not allocated.
- */
-DataArray *DataArrayInt::selectByTupleRanges(const std::vector<std::pair<int,int> >& ranges) const
-{
-  checkAllocated();
-  int nbOfComp=getNumberOfComponents();
-  int nbOfTuplesThis=getNumberOfTuples();
-  if(ranges.empty())
-    {
-      MCAuto<DataArrayInt> ret=DataArrayInt::New();
-      ret->alloc(0,nbOfComp);
-      ret->copyStringInfoFrom(*this);
-      return ret.retn();
-    }
-  int ref=ranges.front().first;
-  int nbOfTuples=0;
-  bool isIncreasing=true;
-  for(std::vector<std::pair<int,int> >::const_iterator it=ranges.begin();it!=ranges.end();it++)
-    {
-      if((*it).first<=(*it).second)
-        {
-          if((*it).first>=0 && (*it).second<=nbOfTuplesThis)
-            {
-              nbOfTuples+=(*it).second-(*it).first;
-              if(isIncreasing)
-                isIncreasing=ref<=(*it).first;
-              ref=(*it).second;
-            }
-          else
-            {
-              std::ostringstream oss; oss << "DataArrayInt::selectByTupleRanges : on range #" << std::distance(ranges.begin(),it);
-              oss << " (" << (*it).first << "," << (*it).second << ") is greater than number of tuples of this :" << nbOfTuples << " !";
-              throw INTERP_KERNEL::Exception(oss.str().c_str());
-            }
-        }
-      else
-        {
-          std::ostringstream oss; oss << "DataArrayInt::selectByTupleRanges : on range #" << std::distance(ranges.begin(),it);
-          oss << " (" << (*it).first << "," << (*it).second << ") end is before begin !";
-          throw INTERP_KERNEL::Exception(oss.str().c_str());
-        }
-    }
-  if(isIncreasing && nbOfTuplesThis==nbOfTuples)
-    return deepCopy();
-  MCAuto<DataArrayInt> ret=DataArrayInt::New();
-  ret->alloc(nbOfTuples,nbOfComp);
-  ret->copyStringInfoFrom(*this);
-  const int *src=getConstPointer();
-  int *work=ret->getPointer();
-  for(std::vector<std::pair<int,int> >::const_iterator it=ranges.begin();it!=ranges.end();it++)
-    work=std::copy(src+(*it).first*nbOfComp,src+(*it).second*nbOfComp,work);
-  return ret.retn();
-}
-
 /*!
  * Returns a new DataArrayInt containing a renumbering map in "Old to New" mode.
  * This map, if applied to \a this array, would make it sorted. For example, if
@@ -7894,180 +5893,7 @@ DataArrayDouble *DataArrayInt::convertToDblArr() const
   double *dest=ret->getPointer();
   std::copy(src,src+nbOfVals,dest);
   ret->copyStringInfoFrom(*this);
-  return ret;
-}
-
-/*!
- * Returns a shorten copy of \a this array. The new DataArrayInt contains all
- * tuples starting from the \a tupleIdBg-th tuple and including all tuples located before
- * the \a tupleIdEnd-th one. This methods has a similar behavior as std::string::substr().
- * This method is a specialization of selectByTupleIdSafeSlice().
- *  \param [in] tupleIdBg - index of the first tuple to copy from \a this array.
- *  \param [in] tupleIdEnd - index of the tuple before which the tuples to copy are located.
- *          If \a tupleIdEnd == -1, all the tuples till the end of \a this array are copied.
- *  \return DataArrayInt * - the new instance of DataArrayInt that the caller
- *          is to delete using decrRef() as it is no more needed.
- *  \throw If \a tupleIdBg < 0.
- *  \throw If \a tupleIdBg > \a this->getNumberOfTuples().
-    \throw If \a tupleIdEnd != -1 && \a tupleIdEnd < \a this->getNumberOfTuples().
- *  \sa DataArrayInt::selectByTupleIdSafeSlice
- */
-DataArrayInt *DataArrayInt::subArray(int tupleIdBg, int tupleIdEnd) const
-{
-  checkAllocated();
-  int nbt=getNumberOfTuples();
-  if(tupleIdBg<0)
-    throw INTERP_KERNEL::Exception("DataArrayInt::subArray : The tupleIdBg parameter must be greater than 0 !");
-  if(tupleIdBg>nbt)
-    throw INTERP_KERNEL::Exception("DataArrayInt::subArray : The tupleIdBg parameter is greater than number of tuples !");
-  int trueEnd=tupleIdEnd;
-  if(tupleIdEnd!=-1)
-    {
-      if(tupleIdEnd>nbt)
-        throw INTERP_KERNEL::Exception("DataArrayInt::subArray : The tupleIdBg parameter is greater or equal than number of tuples !");
-    }
-  else
-    trueEnd=nbt;
-  int nbComp=getNumberOfComponents();
-  MCAuto<DataArrayInt> ret=DataArrayInt::New();
-  ret->alloc(trueEnd-tupleIdBg,nbComp);
-  ret->copyStringInfoFrom(*this);
-  std::copy(getConstPointer()+tupleIdBg*nbComp,getConstPointer()+trueEnd*nbComp,ret->getPointer());
-  return ret.retn();
-}
-
-/*!
- * Changes the number of components within \a this array so that its raw data **does
- * not** change, instead splitting this data into tuples changes.
- *  \warning This method erases all (name and unit) component info set before!
- *  \param [in] newNbOfComp - number of components for \a this array to have.
- *  \throw If \a this is not allocated
- *  \throw If getNbOfElems() % \a newNbOfCompo != 0.
- *  \throw If \a newNbOfCompo is lower than 1.
- *  \throw If the rearrange method would lead to a number of tuples higher than 2147483647 (maximal capacity of int32 !).
- *  \warning This method erases all (name and unit) component info set before!
- */
-void DataArrayInt::rearrange(int newNbOfCompo)
-{
-  checkAllocated();
-  if(newNbOfCompo<1)
-    throw INTERP_KERNEL::Exception("DataArrayInt::rearrange : input newNbOfCompo must be > 0 !");
-  std::size_t nbOfElems=getNbOfElems();
-  if(nbOfElems%newNbOfCompo!=0)
-    throw INTERP_KERNEL::Exception("DataArrayInt::rearrange : nbOfElems%newNbOfCompo!=0 !");
-  if(nbOfElems/newNbOfCompo>(std::size_t)std::numeric_limits<int>::max())
-    throw INTERP_KERNEL::Exception("DataArrayInt::rearrange : the rearrangement leads to too high number of tuples (> 2147483647) !");
-  _info_on_compo.clear();
-  _info_on_compo.resize(newNbOfCompo);
-  declareAsNew();
-}
-
-/*!
- * Changes the number of components within \a this array to be equal to its number
- * of tuples, and inversely its number of tuples to become equal to its number of 
- * components. So that its raw data **does not** change, instead splitting this
- * data into tuples changes.
- *  \warning This method erases all (name and unit) component info set before!
- *  \warning Do not confuse this method with fromNoInterlace() and toNoInterlace()!
- *  \throw If \a this is not allocated.
- *  \sa rearrange()
- */
-void DataArrayInt::transpose()
-{
-  checkAllocated();
-  int nbOfTuples=getNumberOfTuples();
-  rearrange(nbOfTuples);
-}
-
-/*!
- * Returns a shorten or extended copy of \a this array. If \a newNbOfComp is less
- * than \a this->getNumberOfComponents() then the result array is shorten as each tuple
- * is truncated to have \a newNbOfComp components, keeping first components. If \a
- * newNbOfComp is more than \a this->getNumberOfComponents() then the result array is
- * expanded as each tuple is populated with \a dftValue to have \a newNbOfComp
- * components.  
- *  \param [in] newNbOfComp - number of components for the new array to have.
- *  \param [in] dftValue - value assigned to new values added to the new array.
- *  \return DataArrayDouble * - the new instance of DataArrayDouble that the caller
- *          is to delete using decrRef() as it is no more needed.
- *  \throw If \a this is not allocated.
- */
-DataArrayInt *DataArrayInt::changeNbOfComponents(int newNbOfComp, int dftValue) const
-{
-  checkAllocated();
-  MCAuto<DataArrayInt> ret=DataArrayInt::New();
-  ret->alloc(getNumberOfTuples(),newNbOfComp);
-  const int *oldc=getConstPointer();
-  int *nc=ret->getPointer();
-  int nbOfTuples=getNumberOfTuples();
-  int oldNbOfComp=getNumberOfComponents();
-  int dim=std::min(oldNbOfComp,newNbOfComp);
-  for(int i=0;i<nbOfTuples;i++)
-    {
-      int j=0;
-      for(;j<dim;j++)
-        nc[newNbOfComp*i+j]=oldc[i*oldNbOfComp+j];
-      for(;j<newNbOfComp;j++)
-        nc[newNbOfComp*i+j]=dftValue;
-    }
-  ret->setName(getName());
-  for(int i=0;i<dim;i++)
-    ret->setInfoOnComponent(i,getInfoOnComponent(i));
-  ret->setName(getName());
-  return ret.retn();
-}
-
-/*!
- * Changes number of tuples in the array. If the new number of tuples is smaller
- * than the current number the array is truncated, otherwise the array is extended.
- *  \param [in] nbOfTuples - new number of tuples. 
- *  \throw If \a this is not allocated.
- *  \throw If \a nbOfTuples is negative.
- */
-void DataArrayInt::reAlloc(int nbOfTuples)
-{
-  if(nbOfTuples<0)
-    throw INTERP_KERNEL::Exception("DataArrayInt::reAlloc : input new number of tuples should be >=0 !");
-  checkAllocated();
-  _mem.reAlloc(getNumberOfComponents()*(std::size_t)nbOfTuples);
-  declareAsNew();
-}
-
-
-/*!
- * Returns a copy of \a this array composed of selected components.
- * The new DataArrayInt has the same number of tuples but includes components
- * specified by \a compoIds parameter. So that getNbOfElems() of the result array
- * can be either less, same or more than \a this->getNbOfElems().
- *  \param [in] compoIds - sequence of zero based indices of components to include
- *              into the new array.
- *  \return DataArrayInt * - the new instance of DataArrayInt that the caller
- *          is to delete using decrRef() as it is no more needed.
- *  \throw If \a this is not allocated.
- *  \throw If a component index (\a i) is not valid: 
- *         \a i < 0 || \a i >= \a this->getNumberOfComponents().
- *
- *  \if ENABLE_EXAMPLES
- *  \ref py_mcdataarrayint_keepselectedcomponents "Here is a Python example".
- *  \endif
- */
-DataArrayInt *DataArrayInt::keepSelectedComponents(const std::vector<int>& compoIds) const
-{
-  checkAllocated();
-  MCAuto<DataArrayInt> ret(DataArrayInt::New());
-  int newNbOfCompo=(int)compoIds.size();
-  int oldNbOfCompo=getNumberOfComponents();
-  for(std::vector<int>::const_iterator it=compoIds.begin();it!=compoIds.end();it++)
-    DataArray::CheckValueInRange(oldNbOfCompo,(*it),"keepSelectedComponents invalid requested component");
-  int nbOfTuples=getNumberOfTuples();
-  ret->alloc(nbOfTuples,newNbOfCompo);
-  ret->copyPartOfStringInfoFrom(*this,compoIds);
-  const int *oldc=getConstPointer();
-  int *nc=ret->getPointer();
-  for(int i=0;i<nbOfTuples;i++)
-    for(int j=0;j<newNbOfCompo;j++,nc++)
-      *nc=oldc[i*oldNbOfCompo+compoIds[j]];
-  return ret.retn();
+  return ret;
 }
 
 /*!
@@ -8144,686 +5970,6 @@ void DataArrayInt::setSelectedComponents(const DataArrayInt *a, const std::vecto
       nc[nbOfCompo*i+compoIds[j]]=*ac;
 }
 
-/*!
- * Copy all values from another DataArrayInt into specified tuples and components
- * of \a this array. Textual data is not copied.
- * The tree parameters defining set of indices of tuples and components are similar to
- * the tree parameters of the Python function \c range(\c start,\c stop,\c step).
- *  \param [in] a - the array to copy values from.
- *  \param [in] bgTuples - index of the first tuple of \a this array to assign values to.
- *  \param [in] endTuples - index of the tuple before which the tuples to assign to
- *              are located.
- *  \param [in] stepTuples - index increment to get index of the next tuple to assign to.
- *  \param [in] bgComp - index of the first component of \a this array to assign values to.
- *  \param [in] endComp - index of the component before which the components to assign
- *              to are located.
- *  \param [in] stepComp - index increment to get index of the next component to assign to.
- *  \param [in] strictCompoCompare - if \a true (by default), then \a a->getNumberOfComponents() 
- *              must be equal to the number of columns to assign to, else an
- *              exception is thrown; if \a false, then it is only required that \a
- *              a->getNbOfElems() equals to number of values to assign to (this condition
- *              must be respected even if \a strictCompoCompare is \a true). The number of 
- *              values to assign to is given by following Python expression:
- *              \a nbTargetValues = 
- *              \c len(\c range(\a bgTuples,\a endTuples,\a stepTuples)) *
- *              \c len(\c range(\a bgComp,\a endComp,\a stepComp)).
- *  \throw If \a a is NULL.
- *  \throw If \a a is not allocated.
- *  \throw If \a this is not allocated.
- *  \throw If parameters specifying tuples and components to assign to do not give a
- *            non-empty range of increasing indices.
- *  \throw If \a a->getNbOfElems() != \a nbTargetValues.
- *  \throw If \a strictCompoCompare == \a true && \a a->getNumberOfComponents() !=
- *            \c len(\c range(\a bgComp,\a endComp,\a stepComp)).
- *
- *  \if ENABLE_EXAMPLES
- *  \ref py_mcdataarrayint_setpartofvalues1 "Here is a Python example".
- *  \endif
- */
-void DataArrayInt::setPartOfValues1(const DataArrayInt *a, int bgTuples, int endTuples, int stepTuples, int bgComp, int endComp, int stepComp, bool strictCompoCompare)
-{
-  if(!a)
-    throw INTERP_KERNEL::Exception("DataArrayInt::setPartOfValues1 : DataArrayInt pointer in input is NULL !");
-  const char msg[]="DataArrayInt::setPartOfValues1";
-  checkAllocated();
-  a->checkAllocated();
-  int newNbOfTuples=DataArray::GetNumberOfItemGivenBES(bgTuples,endTuples,stepTuples,msg);
-  int newNbOfComp=DataArray::GetNumberOfItemGivenBES(bgComp,endComp,stepComp,msg);
-  int nbComp=getNumberOfComponents();
-  int nbOfTuples=getNumberOfTuples();
-  DataArray::CheckValueInRangeEx(nbOfTuples,bgTuples,endTuples,"invalid tuple value");
-  DataArray::CheckValueInRangeEx(nbComp,bgComp,endComp,"invalid component value");
-  bool assignTech=true;
-  if(a->getNbOfElems()==(std::size_t)newNbOfTuples*newNbOfComp)
-    {
-      if(strictCompoCompare)
-        a->checkNbOfTuplesAndComp(newNbOfTuples,newNbOfComp,msg);
-    }
-  else
-    {
-      a->checkNbOfTuplesAndComp(1,newNbOfComp,msg);
-      assignTech=false;
-    }
-  int *pt=getPointer()+bgTuples*nbComp+bgComp;
-  const int *srcPt=a->getConstPointer();
-  if(assignTech)
-    {
-      for(int i=0;i<newNbOfTuples;i++,pt+=stepTuples*nbComp)
-        for(int j=0;j<newNbOfComp;j++,srcPt++)
-          pt[j*stepComp]=*srcPt;
-    }
-  else
-    {
-      for(int i=0;i<newNbOfTuples;i++,pt+=stepTuples*nbComp)
-        {
-          const int *srcPt2=srcPt;
-          for(int j=0;j<newNbOfComp;j++,srcPt2++)
-            pt[j*stepComp]=*srcPt2;
-        }
-    }
-}
-
-/*!
- * Assign a given value to values at specified tuples and components of \a this array.
- * The tree parameters defining set of indices of tuples and components are similar to
- * the tree parameters of the Python function \c range(\c start,\c stop,\c step)..
- *  \param [in] a - the value to assign.
- *  \param [in] bgTuples - index of the first tuple of \a this array to assign to.
- *  \param [in] endTuples - index of the tuple before which the tuples to assign to
- *              are located.
- *  \param [in] stepTuples - index increment to get index of the next tuple to assign to.
- *  \param [in] bgComp - index of the first component of \a this array to assign to.
- *  \param [in] endComp - index of the component before which the components to assign
- *              to are located.
- *  \param [in] stepComp - index increment to get index of the next component to assign to.
- *  \throw If \a this is not allocated.
- *  \throw If parameters specifying tuples and components to assign to, do not give a
- *            non-empty range of increasing indices or indices are out of a valid range
- *            for \c this array.
- *
- *  \if ENABLE_EXAMPLES
- *  \ref py_mcdataarrayint_setpartofvaluessimple1 "Here is a Python example".
- *  \endif
- */
-void DataArrayInt::setPartOfValuesSimple1(int a, int bgTuples, int endTuples, int stepTuples, int bgComp, int endComp, int stepComp)
-{
-  const char msg[]="DataArrayInt::setPartOfValuesSimple1";
-  checkAllocated();
-  int newNbOfTuples=DataArray::GetNumberOfItemGivenBES(bgTuples,endTuples,stepTuples,msg);
-  int newNbOfComp=DataArray::GetNumberOfItemGivenBES(bgComp,endComp,stepComp,msg);
-  int nbComp=getNumberOfComponents();
-  int nbOfTuples=getNumberOfTuples();
-  DataArray::CheckValueInRangeEx(nbOfTuples,bgTuples,endTuples,"invalid tuple value");
-  DataArray::CheckValueInRangeEx(nbComp,bgComp,endComp,"invalid component value");
-  int *pt=getPointer()+bgTuples*nbComp+bgComp;
-  for(int i=0;i<newNbOfTuples;i++,pt+=stepTuples*nbComp)
-    for(int j=0;j<newNbOfComp;j++)
-      pt[j*stepComp]=a;
-}
-
-
-/*!
- * Copy all values from another DataArrayInt (\a a) into specified tuples and 
- * components of \a this array. Textual data is not copied.
- * The tuples and components to assign to are defined by C arrays of indices.
- * There are two *modes of usage*:
- * - If \a a->getNbOfElems() equals to number of values to assign to, then every value
- *   of \a a is assigned to its own location within \a this array. 
- * - If \a a includes one tuple, then all values of \a a are assigned to the specified
- *   components of every specified tuple of \a this array. In this mode it is required
- *   that \a a->getNumberOfComponents() equals to the number of specified components.
- * 
- *  \param [in] a - the array to copy values from.
- *  \param [in] bgTuples - pointer to an array of tuple indices of \a this array to
- *              assign values of \a a to.
- *  \param [in] endTuples - specifies the end of the array \a bgTuples, so that
- *              pointer to a tuple index <em>(pi)</em> varies as this: 
- *              \a bgTuples <= \a pi < \a endTuples.
- *  \param [in] bgComp - pointer to an array of component indices of \a this array to
- *              assign values of \a a to.
- *  \param [in] endComp - specifies the end of the array \a bgTuples, so that
- *              pointer to a component index <em>(pi)</em> varies as this: 
- *              \a bgComp <= \a pi < \a endComp.
- *  \param [in] strictCompoCompare - this parameter is checked only if the
- *               *mode of usage* is the first; if it is \a true (default), 
- *               then \a a->getNumberOfComponents() must be equal 
- *               to the number of specified columns, else this is not required.
- *  \throw If \a a is NULL.
- *  \throw If \a a is not allocated.
- *  \throw If \a this is not allocated.
- *  \throw If any index of tuple/component given by <em>bgTuples / bgComp</em> is
- *         out of a valid range for \a this array.
- *  \throw In the first *mode of usage*, if <em>strictCompoCompare == true </em> and
- *         if <em> a->getNumberOfComponents() != (endComp - bgComp) </em>.
- *  \throw In the second *mode of usage*, if \a a->getNumberOfTuples() != 1 or
- *         <em> a->getNumberOfComponents() != (endComp - bgComp)</em>.
- *
- *  \if ENABLE_EXAMPLES
- *  \ref py_mcdataarrayint_setpartofvalues2 "Here is a Python example".
- *  \endif
- */
-void DataArrayInt::setPartOfValues2(const DataArrayInt *a, const int *bgTuples, const int *endTuples, const int *bgComp, const int *endComp, bool strictCompoCompare)
-{
-  if(!a)
-    throw INTERP_KERNEL::Exception("DataArrayInt::setPartOfValues2 : DataArrayInt pointer in input is NULL !");
-  const char msg[]="DataArrayInt::setPartOfValues2";
-  checkAllocated();
-  a->checkAllocated();
-  int nbComp=getNumberOfComponents();
-  int nbOfTuples=getNumberOfTuples();
-  for(const int *z=bgComp;z!=endComp;z++)
-    DataArray::CheckValueInRange(nbComp,*z,"invalid component id");
-  int newNbOfTuples=(int)std::distance(bgTuples,endTuples);
-  int newNbOfComp=(int)std::distance(bgComp,endComp);
-  bool assignTech=true;
-  if(a->getNbOfElems()==(std::size_t)newNbOfTuples*newNbOfComp)
-    {
-      if(strictCompoCompare)
-        a->checkNbOfTuplesAndComp(newNbOfTuples,newNbOfComp,msg);
-    }
-  else
-    {
-      a->checkNbOfTuplesAndComp(1,newNbOfComp,msg);
-      assignTech=false;
-    }
-  int *pt=getPointer();
-  const int *srcPt=a->getConstPointer();
-  if(assignTech)
-    {    
-      for(const int *w=bgTuples;w!=endTuples;w++)
-        {
-          DataArray::CheckValueInRange(nbOfTuples,*w,"invalid tuple id");
-          for(const int *z=bgComp;z!=endComp;z++,srcPt++)
-            {    
-              pt[(std::size_t)(*w)*nbComp+(*z)]=*srcPt;
-            }
-        }
-    }
-  else
-    {
-      for(const int *w=bgTuples;w!=endTuples;w++)
-        {
-          const int *srcPt2=srcPt;
-          DataArray::CheckValueInRange(nbOfTuples,*w,"invalid tuple id");
-          for(const int *z=bgComp;z!=endComp;z++,srcPt2++)
-            {    
-              pt[(std::size_t)(*w)*nbComp+(*z)]=*srcPt2;
-            }
-        }
-    }
-}
-
-/*!
- * Assign a given value to values at specified tuples and components of \a this array.
- * The tuples and components to assign to are defined by C arrays of indices.
- *  \param [in] a - the value to assign.
- *  \param [in] bgTuples - pointer to an array of tuple indices of \a this array to
- *              assign \a a to.
- *  \param [in] endTuples - specifies the end of the array \a bgTuples, so that
- *              pointer to a tuple index (\a pi) varies as this: 
- *              \a bgTuples <= \a pi < \a endTuples.
- *  \param [in] bgComp - pointer to an array of component indices of \a this array to
- *              assign \a a to.
- *  \param [in] endComp - specifies the end of the array \a bgTuples, so that
- *              pointer to a component index (\a pi) varies as this: 
- *              \a bgComp <= \a pi < \a endComp.
- *  \throw If \a this is not allocated.
- *  \throw If any index of tuple/component given by <em>bgTuples / bgComp</em> is
- *         out of a valid range for \a this array.
- *
- *  \if ENABLE_EXAMPLES
- *  \ref py_mcdataarrayint_setpartofvaluessimple2 "Here is a Python example".
- *  \endif
- */
-void DataArrayInt::setPartOfValuesSimple2(int a, const int *bgTuples, const int *endTuples, const int *bgComp, const int *endComp)
-{
-  checkAllocated();
-  int nbComp=getNumberOfComponents();
-  int nbOfTuples=getNumberOfTuples();
-  for(const int *z=bgComp;z!=endComp;z++)
-    DataArray::CheckValueInRange(nbComp,*z,"invalid component id");
-  int *pt=getPointer();
-  for(const int *w=bgTuples;w!=endTuples;w++)
-    for(const int *z=bgComp;z!=endComp;z++)
-      {
-        DataArray::CheckValueInRange(nbOfTuples,*w,"invalid tuple id");
-        pt[(std::size_t)(*w)*nbComp+(*z)]=a;
-      }
-}
-
-/*!
- * Copy all values from another DataArrayInt (\a a) into specified tuples and 
- * components of \a this array. Textual data is not copied.
- * The tuples to assign to are defined by a C array of indices.
- * The components to assign to are defined by three values similar to parameters of
- * the Python function \c range(\c start,\c stop,\c step).
- * There are two *modes of usage*:
- * - If \a a->getNbOfElems() equals to number of values to assign to, then every value
- *   of \a a is assigned to its own location within \a this array. 
- * - If \a a includes one tuple, then all values of \a a are assigned to the specified
- *   components of every specified tuple of \a this array. In this mode it is required
- *   that \a a->getNumberOfComponents() equals to the number of specified components.
- *
- *  \param [in] a - the array to copy values from.
- *  \param [in] bgTuples - pointer to an array of tuple indices of \a this array to
- *              assign values of \a a to.
- *  \param [in] endTuples - specifies the end of the array \a bgTuples, so that
- *              pointer to a tuple index <em>(pi)</em> varies as this: 
- *              \a bgTuples <= \a pi < \a endTuples.
- *  \param [in] bgComp - index of the first component of \a this array to assign to.
- *  \param [in] endComp - index of the component before which the components to assign
- *              to are located.
- *  \param [in] stepComp - index increment to get index of the next component to assign to.
- *  \param [in] strictCompoCompare - this parameter is checked only in the first
- *               *mode of usage*; if \a strictCompoCompare is \a true (default), 
- *               then \a a->getNumberOfComponents() must be equal 
- *               to the number of specified columns, else this is not required.
- *  \throw If \a a is NULL.
- *  \throw If \a a is not allocated.
- *  \throw If \a this is not allocated.
- *  \throw If any index of tuple given by \a bgTuples is out of a valid range for 
- *         \a this array.
- *  \throw In the first *mode of usage*, if <em>strictCompoCompare == true </em> and
- *         if <em> a->getNumberOfComponents()</em> is unequal to the number of components
- *         defined by <em>(bgComp,endComp,stepComp)</em>.
- *  \throw In the second *mode of usage*, if \a a->getNumberOfTuples() != 1 or
- *         <em> a->getNumberOfComponents()</em> is unequal to the number of components
- *         defined by <em>(bgComp,endComp,stepComp)</em>.
- *  \throw If parameters specifying components to assign to, do not give a
- *            non-empty range of increasing indices or indices are out of a valid range
- *            for \c this array.
- *
- *  \if ENABLE_EXAMPLES
- *  \ref py_mcdataarrayint_setpartofvalues3 "Here is a Python example".
- *  \endif
- */
-void DataArrayInt::setPartOfValues3(const DataArrayInt *a, const int *bgTuples, const int *endTuples, int bgComp, int endComp, int stepComp, bool strictCompoCompare)
-{
-  if(!a)
-    throw INTERP_KERNEL::Exception("DataArrayInt::setPartOfValues3 : DataArrayInt pointer in input is NULL !");
-  const char msg[]="DataArrayInt::setPartOfValues3";
-  checkAllocated();
-  a->checkAllocated();
-  int newNbOfComp=DataArray::GetNumberOfItemGivenBES(bgComp,endComp,stepComp,msg);
-  int nbComp=getNumberOfComponents();
-  int nbOfTuples=getNumberOfTuples();
-  DataArray::CheckValueInRangeEx(nbComp,bgComp,endComp,"invalid component value");
-  int newNbOfTuples=(int)std::distance(bgTuples,endTuples);
-  bool assignTech=true;
-  if(a->getNbOfElems()==(std::size_t)newNbOfTuples*newNbOfComp)
-    {
-      if(strictCompoCompare)
-        a->checkNbOfTuplesAndComp(newNbOfTuples,newNbOfComp,msg);
-    }
-  else
-    {
-      a->checkNbOfTuplesAndComp(1,newNbOfComp,msg);
-      assignTech=false;
-    }
-  int *pt=getPointer()+bgComp;
-  const int *srcPt=a->getConstPointer();
-  if(assignTech)
-    {
-      for(const int *w=bgTuples;w!=endTuples;w++)
-        for(int j=0;j<newNbOfComp;j++,srcPt++)
-          {
-            DataArray::CheckValueInRange(nbOfTuples,*w,"invalid tuple id");
-            pt[(std::size_t)(*w)*nbComp+j*stepComp]=*srcPt;
-          }
-    }
-  else
-    {
-      for(const int *w=bgTuples;w!=endTuples;w++)
-        {
-          const int *srcPt2=srcPt;
-          for(int j=0;j<newNbOfComp;j++,srcPt2++)
-            {
-              DataArray::CheckValueInRange(nbOfTuples,*w,"invalid tuple id");
-              pt[(std::size_t)(*w)*nbComp+j*stepComp]=*srcPt2;
-            }
-        }
-    }
-}
-
-/*!
- * Assign a given value to values at specified tuples and components of \a this array.
- * The tuples to assign to are defined by a C array of indices.
- * The components to assign to are defined by three values similar to parameters of
- * the Python function \c range(\c start,\c stop,\c step).
- *  \param [in] a - the value to assign.
- *  \param [in] bgTuples - pointer to an array of tuple indices of \a this array to
- *              assign \a a to.
- *  \param [in] endTuples - specifies the end of the array \a bgTuples, so that
- *              pointer to a tuple index <em>(pi)</em> varies as this: 
- *              \a bgTuples <= \a pi < \a endTuples.
- *  \param [in] bgComp - index of the first component of \a this array to assign to.
- *  \param [in] endComp - index of the component before which the components to assign
- *              to are located.
- *  \param [in] stepComp - index increment to get index of the next component to assign to.
- *  \throw If \a this is not allocated.
- *  \throw If any index of tuple given by \a bgTuples is out of a valid range for 
- *         \a this array.
- *  \throw If parameters specifying components to assign to, do not give a
- *            non-empty range of increasing indices or indices are out of a valid range
- *            for \c this array.
- *
- *  \if ENABLE_EXAMPLES
- *  \ref py_mcdataarrayint_setpartofvaluessimple3 "Here is a Python example".
- *  \endif
- */
-void DataArrayInt::setPartOfValuesSimple3(int a, const int *bgTuples, const int *endTuples, int bgComp, int endComp, int stepComp)
-{
-  const char msg[]="DataArrayInt::setPartOfValuesSimple3";
-  checkAllocated();
-  int newNbOfComp=DataArray::GetNumberOfItemGivenBES(bgComp,endComp,stepComp,msg);
-  int nbComp=getNumberOfComponents();
-  int nbOfTuples=getNumberOfTuples();
-  DataArray::CheckValueInRangeEx(nbComp,bgComp,endComp,"invalid component value");
-  int *pt=getPointer()+bgComp;
-  for(const int *w=bgTuples;w!=endTuples;w++)
-    for(int j=0;j<newNbOfComp;j++)
-      {
-        DataArray::CheckValueInRange(nbOfTuples,*w,"invalid tuple id");
-        pt[(std::size_t)(*w)*nbComp+j*stepComp]=a;
-      }
-}
-
-void DataArrayInt::setPartOfValues4(const DataArrayInt *a, int bgTuples, int endTuples, int stepTuples, const int *bgComp, const int *endComp, bool strictCompoCompare)
-{
-  if(!a)
-    throw INTERP_KERNEL::Exception("DataArrayInt::setPartOfValues4 : input DataArrayInt is NULL !");
-  const char msg[]="DataArrayInt::setPartOfValues4";
-  checkAllocated();
-  a->checkAllocated();
-  int newNbOfTuples=DataArray::GetNumberOfItemGivenBES(bgTuples,endTuples,stepTuples,msg);
-  int newNbOfComp=(int)std::distance(bgComp,endComp);
-  int nbComp=getNumberOfComponents();
-  for(const int *z=bgComp;z!=endComp;z++)
-    DataArray::CheckValueInRange(nbComp,*z,"invalid component id");
-  int nbOfTuples=getNumberOfTuples();
-  DataArray::CheckValueInRangeEx(nbOfTuples,bgTuples,endTuples,"invalid tuple value");
-  bool assignTech=true;
-  if(a->getNbOfElems()==(std::size_t)newNbOfTuples*newNbOfComp)
-    {
-      if(strictCompoCompare)
-        a->checkNbOfTuplesAndComp(newNbOfTuples,newNbOfComp,msg);
-    }
-  else
-    {
-      a->checkNbOfTuplesAndComp(1,newNbOfComp,msg);
-      assignTech=false;
-    }
-  const int *srcPt=a->getConstPointer();
-  int *pt=getPointer()+bgTuples*nbComp;
-  if(assignTech)
-    {
-      for(int i=0;i<newNbOfTuples;i++,pt+=stepTuples*nbComp)
-        for(const int *z=bgComp;z!=endComp;z++,srcPt++)
-          pt[*z]=*srcPt;
-    }
-  else
-    {
-      for(int i=0;i<newNbOfTuples;i++,pt+=stepTuples*nbComp)
-        {
-          const int *srcPt2=srcPt;
-          for(const int *z=bgComp;z!=endComp;z++,srcPt2++)
-            pt[*z]=*srcPt2;
-        }
-    }
-}
-
-void DataArrayInt::setPartOfValuesSimple4(int a, int bgTuples, int endTuples, int stepTuples, const int *bgComp, const int *endComp)
-{
-  const char msg[]="DataArrayInt::setPartOfValuesSimple4";
-  checkAllocated();
-  int newNbOfTuples=DataArray::GetNumberOfItemGivenBES(bgTuples,endTuples,stepTuples,msg);
-  int nbComp=getNumberOfComponents();
-  for(const int *z=bgComp;z!=endComp;z++)
-    DataArray::CheckValueInRange(nbComp,*z,"invalid component id");
-  int nbOfTuples=getNumberOfTuples();
-  DataArray::CheckValueInRangeEx(nbOfTuples,bgTuples,endTuples,"invalid tuple value");
-  int *pt=getPointer()+bgTuples*nbComp;
-  for(int i=0;i<newNbOfTuples;i++,pt+=stepTuples*nbComp)
-    for(const int *z=bgComp;z!=endComp;z++)
-      pt[*z]=a;
-}
-
-/*!
- * Copy some tuples from another DataArrayInt into specified tuples
- * of \a this array. Textual data is not copied. Both arrays must have equal number of
- * components.
- * Both the tuples to assign and the tuples to assign to are defined by a DataArrayInt.
- * All components of selected tuples are copied.
- *  \param [in] a - the array to copy values from.
- *  \param [in] tuplesSelec - the array specifying both source tuples of \a a and
- *              target tuples of \a this. \a tuplesSelec has two components, and the
- *              first component specifies index of the source tuple and the second
- *              one specifies index of the target tuple.
- *  \throw If \a this is not allocated.
- *  \throw If \a a is NULL.
- *  \throw If \a a is not allocated.
- *  \throw If \a tuplesSelec is NULL.
- *  \throw If \a tuplesSelec is not allocated.
- *  \throw If <em>this->getNumberOfComponents() != a->getNumberOfComponents()</em>.
- *  \throw If \a tuplesSelec->getNumberOfComponents() != 2.
- *  \throw If any tuple index given by \a tuplesSelec is out of a valid range for 
- *         the corresponding (\a this or \a a) array.
- */
-void DataArrayInt::setPartOfValuesAdv(const DataArrayInt *a, const DataArrayInt *tuplesSelec)
-{
-  if(!a || !tuplesSelec)
-    throw INTERP_KERNEL::Exception("DataArrayInt::setPartOfValuesAdv : DataArrayInt pointer in input is NULL !");
-  checkAllocated();
-  a->checkAllocated();
-  tuplesSelec->checkAllocated();
-  int nbOfComp=getNumberOfComponents();
-  if(nbOfComp!=a->getNumberOfComponents())
-    throw INTERP_KERNEL::Exception("DataArrayInt::setPartOfValuesAdv : This and a do not have the same number of components !");
-  if(tuplesSelec->getNumberOfComponents()!=2)
-    throw INTERP_KERNEL::Exception("DataArrayInt::setPartOfValuesAdv : Expecting to have a tuple selector DataArrayInt instance with exactly 2 components !");
-  int thisNt=getNumberOfTuples();
-  int aNt=a->getNumberOfTuples();
-  int *valsToSet=getPointer();
-  const int *valsSrc=a->getConstPointer();
-  for(const int *tuple=tuplesSelec->begin();tuple!=tuplesSelec->end();tuple+=2)
-    {
-      if(tuple[1]>=0 && tuple[1]<aNt)
-        {
-          if(tuple[0]>=0 && tuple[0]<thisNt)
-            std::copy(valsSrc+nbOfComp*tuple[1],valsSrc+nbOfComp*(tuple[1]+1),valsToSet+nbOfComp*tuple[0]);
-          else
-            {
-              std::ostringstream oss; oss << "DataArrayInt::setPartOfValuesAdv : Tuple #" << std::distance(tuplesSelec->begin(),tuple)/2;
-              oss << " of 'tuplesSelec' request of tuple id #" << tuple[0] << " in 'this' ! It should be in [0," << thisNt << ") !";
-              throw INTERP_KERNEL::Exception(oss.str().c_str());
-            }
-        }
-      else
-        {
-          std::ostringstream oss; oss << "DataArrayInt::setPartOfValuesAdv : Tuple #" << std::distance(tuplesSelec->begin(),tuple)/2;
-          oss << " of 'tuplesSelec' request of tuple id #" << tuple[1] << " in 'a' ! It should be in [0," << aNt << ") !";
-          throw INTERP_KERNEL::Exception(oss.str().c_str());
-        }
-    }
-}
-
-/*!
- * Copy some tuples from another DataArrayInt (\a aBase) into contiguous tuples
- * of \a this array. Textual data is not copied. Both arrays must have equal number of
- * components.
- * The tuples to assign to are defined by index of the first tuple, and
- * their number is defined by \a tuplesSelec->getNumberOfTuples().
- * The tuples to copy are defined by values of a DataArrayInt.
- * All components of selected tuples are copied.
- *  \param [in] tupleIdStart - index of the first tuple of \a this array to assign
- *              values to.
- *  \param [in] aBase - the array to copy values from.
- *  \param [in] tuplesSelec - the array specifying tuples of \a aBase to copy.
- *  \throw If \a this is not allocated.
- *  \throw If \a aBase is NULL.
- *  \throw If \a aBase is not allocated.
- *  \throw If \a tuplesSelec is NULL.
- *  \throw If \a tuplesSelec is not allocated.
- *  \throw If <em>this->getNumberOfComponents() != a->getNumberOfComponents()</em>.
- *  \throw If \a tuplesSelec->getNumberOfComponents() != 1.
- *  \throw If <em>tupleIdStart + tuplesSelec->getNumberOfTuples() > this->getNumberOfTuples().</em>
- *  \throw If any tuple index given by \a tuplesSelec is out of a valid range for 
- *         \a aBase array.
- */
-void DataArrayInt::setContigPartOfSelectedValues(int tupleIdStart, const DataArray *aBase, const DataArrayInt *tuplesSelec)
-{
-  if(!aBase || !tuplesSelec)
-    throw INTERP_KERNEL::Exception("DataArrayInt::setContigPartOfSelectedValues : input DataArray is NULL !");
-  const DataArrayInt *a=dynamic_cast<const DataArrayInt *>(aBase);
-  if(!a)
-    throw INTERP_KERNEL::Exception("DataArrayInt::setContigPartOfSelectedValues : input DataArray aBase is not a DataArrayInt !");
-  checkAllocated();
-  a->checkAllocated();
-  tuplesSelec->checkAllocated();
-  int nbOfComp=getNumberOfComponents();
-  if(nbOfComp!=a->getNumberOfComponents())
-    throw INTERP_KERNEL::Exception("DataArrayInt::setContigPartOfSelectedValues : This and a do not have the same number of components !");
-  if(tuplesSelec->getNumberOfComponents()!=1)
-    throw INTERP_KERNEL::Exception("DataArrayInt::setContigPartOfSelectedValues : Expecting to have a tuple selector DataArrayInt instance with exactly 1 component !");
-  int thisNt=getNumberOfTuples();
-  int aNt=a->getNumberOfTuples();
-  int nbOfTupleToWrite=tuplesSelec->getNumberOfTuples();
-  int *valsToSet=getPointer()+tupleIdStart*nbOfComp;
-  if(tupleIdStart+nbOfTupleToWrite>thisNt)
-    throw INTERP_KERNEL::Exception("DataArrayInt::setContigPartOfSelectedValues : invalid number range of values to write !");
-  const int *valsSrc=a->getConstPointer();
-  for(const int *tuple=tuplesSelec->begin();tuple!=tuplesSelec->end();tuple++,valsToSet+=nbOfComp)
-    {
-      if(*tuple>=0 && *tuple<aNt)
-        {
-          std::copy(valsSrc+nbOfComp*(*tuple),valsSrc+nbOfComp*(*tuple+1),valsToSet);
-        }
-      else
-        {
-          std::ostringstream oss; oss << "DataArrayInt::setContigPartOfSelectedValues : Tuple #" << std::distance(tuplesSelec->begin(),tuple);
-          oss << " of 'tuplesSelec' request of tuple id #" << *tuple << " in 'a' ! It should be in [0," << aNt << ") !";
-          throw INTERP_KERNEL::Exception(oss.str().c_str());
-        }
-    }
-}
-
-/*!
- * Copy some tuples from another DataArrayInt (\a aBase) into contiguous tuples
- * of \a this array. Textual data is not copied. Both arrays must have equal number of
- * components.
- * The tuples to copy are defined by three values similar to parameters of
- * the Python function \c range(\c start,\c stop,\c step).
- * The tuples to assign to are defined by index of the first tuple, and
- * their number is defined by number of tuples to copy.
- * All components of selected tuples are copied.
- *  \param [in] tupleIdStart - index of the first tuple of \a this array to assign
- *              values to.
- *  \param [in] aBase - the array to copy values from.
- *  \param [in] bg - index of the first tuple to copy of the array \a aBase.
- *  \param [in] end2 - index of the tuple of \a aBase before which the tuples to copy
- *              are located.
- *  \param [in] step - index increment to get index of the next tuple to copy.
- *  \throw If \a this is not allocated.
- *  \throw If \a aBase is NULL.
- *  \throw If \a aBase is not allocated.
- *  \throw If <em>this->getNumberOfComponents() != aBase->getNumberOfComponents()</em>.
- *  \throw If <em>tupleIdStart + len(range(bg,end2,step)) > this->getNumberOfTuples().</em>
- *  \throw If parameters specifying tuples to copy, do not give a
- *            non-empty range of increasing indices or indices are out of a valid range
- *            for the array \a aBase.
- */
-void DataArrayInt::setContigPartOfSelectedValuesSlice(int tupleIdStart, const DataArray *aBase, int bg, int end2, int step)
-{
-  if(!aBase)
-    throw INTERP_KERNEL::Exception("DataArrayInt::setContigPartOfSelectedValuesSlice : input DataArray is NULL !");
-  const DataArrayInt *a=dynamic_cast<const DataArrayInt *>(aBase);
-  if(!a)
-    throw INTERP_KERNEL::Exception("DataArrayInt::setContigPartOfSelectedValuesSlice : input DataArray aBase is not a DataArrayInt !");
-  checkAllocated();
-  a->checkAllocated();
-  int nbOfComp=getNumberOfComponents();
-  const char msg[]="DataArrayInt::setContigPartOfSelectedValuesSlice";
-  int nbOfTupleToWrite=DataArray::GetNumberOfItemGivenBES(bg,end2,step,msg);
-  if(nbOfComp!=a->getNumberOfComponents())
-    throw INTERP_KERNEL::Exception("DataArrayInt::setContigPartOfSelectedValuesSlice : This and a do not have the same number of components !");
-  int thisNt=getNumberOfTuples();
-  int aNt=a->getNumberOfTuples();
-  int *valsToSet=getPointer()+tupleIdStart*nbOfComp;
-  if(tupleIdStart+nbOfTupleToWrite>thisNt)
-    throw INTERP_KERNEL::Exception("DataArrayInt::setContigPartOfSelectedValuesSlice : invalid number range of values to write !");
-  if(end2>aNt)
-    throw INTERP_KERNEL::Exception("DataArrayInt::setContigPartOfSelectedValuesSlice : invalid range of values to read !");
-  const int *valsSrc=a->getConstPointer()+bg*nbOfComp;
-  for(int i=0;i<nbOfTupleToWrite;i++,valsToSet+=nbOfComp,valsSrc+=step*nbOfComp)
-    {
-      std::copy(valsSrc,valsSrc+nbOfComp,valsToSet);
-    }
-}
-
-/*!
- * Returns a value located at specified tuple and component.
- * This method is equivalent to DataArrayInt::getIJ() except that validity of
- * parameters is checked. So this method is safe but expensive if used to go through
- * all values of \a this.
- *  \param [in] tupleId - index of tuple of interest.
- *  \param [in] compoId - index of component of interest.
- *  \return double - value located by \a tupleId and \a compoId.
- *  \throw If \a this is not allocated.
- *  \throw If condition <em>( 0 <= tupleId < this->getNumberOfTuples() )</em> is violated.
- *  \throw If condition <em>( 0 <= compoId < this->getNumberOfComponents() )</em> is violated.
- */
-int DataArrayInt::getIJSafe(int tupleId, int compoId) const
-{
-  checkAllocated();
-  if(tupleId<0 || tupleId>=getNumberOfTuples())
-    {
-      std::ostringstream oss; oss << "DataArrayInt::getIJSafe : request for tupleId " << tupleId << " should be in [0," << getNumberOfTuples() << ") !";
-      throw INTERP_KERNEL::Exception(oss.str().c_str());
-    }
-  if(compoId<0 || compoId>=getNumberOfComponents())
-    {
-      std::ostringstream oss; oss << "DataArrayInt::getIJSafe : request for compoId " << compoId << " should be in [0," << getNumberOfComponents() << ") !";
-      throw INTERP_KERNEL::Exception(oss.str().c_str());
-    }
-  return _mem[tupleId*_info_on_compo.size()+compoId];
-}
-
-/*!
- * Returns the first value of \a this. 
- *  \return int - the last value of \a this array.
- *  \throw If \a this is not allocated.
- *  \throw If \a this->getNumberOfComponents() != 1.
- *  \throw If \a this->getNumberOfTuples() < 1.
- */
-int DataArrayInt::front() const
-{
-  checkAllocated();
-  if(getNumberOfComponents()!=1)
-    throw INTERP_KERNEL::Exception("DataArrayInt::front : number of components not equal to one !");
-  int nbOfTuples=getNumberOfTuples();
-  if(nbOfTuples<1)
-    throw INTERP_KERNEL::Exception("DataArrayInt::front : number of tuples must be >= 1 !");
-  return *(getConstPointer());
-}
-
-/*!
- * Returns the last value of \a this. 
- *  \return int - the last value of \a this array.
- *  \throw If \a this is not allocated.
- *  \throw If \a this->getNumberOfComponents() != 1.
- *  \throw If \a this->getNumberOfTuples() < 1.
- */
-int DataArrayInt::back() const
-{
-  checkAllocated();
-  if(getNumberOfComponents()!=1)
-    throw INTERP_KERNEL::Exception("DataArrayInt::back : number of components not equal to one !");
-  int nbOfTuples=getNumberOfTuples();
-  if(nbOfTuples<1)
-    throw INTERP_KERNEL::Exception("DataArrayInt::back : number of tuples must be >= 1 !");
-  return *(getConstPointer()+nbOfTuples-1);
-}
-
 /*!
  * Assign pointer to one array to a pointer to another appay. Reference counter of
  * \a arrayToSet is incremented / decremented.
@@ -9391,74 +6537,6 @@ DataArrayInt *DataArrayInt::AggregateIndexes(const std::vector<const DataArrayIn
   return ret.retn();
 }
 
-/*!
- * Returns the maximal value and its location within \a this one-dimensional array.
- *  \param [out] tupleId - index of the tuple holding the maximal value.
- *  \return int - the maximal value among all values of \a this array.
- *  \throw If \a this->getNumberOfComponents() != 1
- *  \throw If \a this->getNumberOfTuples() < 1
- */
-int DataArrayInt::getMaxValue(int& tupleId) const
-{
-  checkAllocated();
-  if(getNumberOfComponents()!=1)
-    throw INTERP_KERNEL::Exception("DataArrayInt::getMaxValue : must be applied on DataArrayInt with only one component !");
-  int nbOfTuples=getNumberOfTuples();
-  if(nbOfTuples<=0)
-    throw INTERP_KERNEL::Exception("DataArrayInt::getMaxValue : array exists but number of tuples must be > 0 !");
-  const int *vals=getConstPointer();
-  const int *loc=std::max_element(vals,vals+nbOfTuples);
-  tupleId=(int)std::distance(vals,loc);
-  return *loc;
-}
-
-/*!
- * Returns the maximal value within \a this array that is allowed to have more than
- *  one component.
- *  \return int - the maximal value among all values of \a this array.
- *  \throw If \a this is not allocated.
- */
-int DataArrayInt::getMaxValueInArray() const
-{
-  checkAllocated();
-  const int *loc=std::max_element(begin(),end());
-  return *loc;
-}
-
-/*!
- * Returns the minimal value and its location within \a this one-dimensional array.
- *  \param [out] tupleId - index of the tuple holding the minimal value.
- *  \return int - the minimal value among all values of \a this array.
- *  \throw If \a this->getNumberOfComponents() != 1
- *  \throw If \a this->getNumberOfTuples() < 1
- */
-int DataArrayInt::getMinValue(int& tupleId) const
-{
-  checkAllocated();
-  if(getNumberOfComponents()!=1)
-    throw INTERP_KERNEL::Exception("DataArrayInt::getMaxValue : must be applied on DataArrayInt with only one component !");
-  int nbOfTuples=getNumberOfTuples();
-  if(nbOfTuples<=0)
-    throw INTERP_KERNEL::Exception("DataArrayInt::getMaxValue : array exists but number of tuples must be > 0 !");
-  const int *vals=getConstPointer();
-  const int *loc=std::min_element(vals,vals+nbOfTuples);
-  tupleId=(int)std::distance(vals,loc);
-  return *loc;
-}
-
-/*!
- * Returns the minimal value within \a this array that is allowed to have more than
- *  one component.
- *  \return int - the minimal value among all values of \a this array.
- *  \throw If \a this is not allocated.
- */
-int DataArrayInt::getMinValueInArray() const
-{
-  checkAllocated();
-  const int *loc=std::min_element(begin(),end());
-  return *loc;
-}
-
 /*!
  * Returns in a single walk in \a this the min value and the max value in \a this.
  * \a this is expected to be single component array.