]> SALOME platform Git repositories - tools/medcoupling.git/commitdiff
Salome HOME
On the way to de-warning-isation: missing breaks, shadow variable, etc ...
authorabn <adrien.bruneton@cea.fr>
Tue, 22 Sep 2020 11:29:39 +0000 (13:29 +0200)
committerabn <adrien.bruneton@cea.fr>
Thu, 24 Sep 2020 14:11:24 +0000 (16:11 +0200)
54 files changed:
src/INTERP_KERNEL/GaussPoints/InterpKernelGaussCoords.cxx
src/INTERP_KERNEL/Geometric2D/InterpKernelGeo2DEdgeArcCircle.cxx
src/INTERP_KERNEL/Geometric2D/InterpKernelGeo2DEdgeLin.cxx
src/INTERP_KERNEL/SplitterTetra.txx
src/INTERP_KERNELTest/PerfTest.cxx
src/INTERP_KERNELTest/QuadraticPlanarInterpTest5.cxx
src/INTERP_KERNELTest/SingleElementPlanarTests.cxx
src/MEDCoupling/MEDCoupling1GTUMesh.cxx
src/MEDCoupling/MEDCouplingCurveLinearMesh.cxx
src/MEDCoupling/MEDCouplingGaussLocalization.cxx
src/MEDCoupling/MEDCouplingMemArray.cxx
src/MEDCoupling/MEDCouplingMemArray.txx
src/MEDCoupling/MEDCouplingPointSet.cxx
src/MEDCoupling/MEDCouplingRemapper.cxx
src/MEDCoupling/MEDCouplingUMesh.cxx
src/MEDCoupling/MEDCouplingUMesh_internal.cxx
src/MEDCoupling/Test/MEDCouplingBasicsTest0.cxx
src/MEDCoupling/Test/MEDCouplingBasicsTestData1.hxx
src/MEDCoupling/Test/MEDCouplingExamplesTest.cxx
src/MEDCoupling_Swig/MEDCouplingDataArrayTypemaps.i
src/MEDLoader/MEDFileBlowStrEltUp.cxx
src/MEDLoader/MEDFileEquivalence.cxx
src/MEDLoader/MEDFileField.cxx
src/MEDLoader/MEDFileField1TS.cxx
src/MEDLoader/MEDFileFieldInternal.cxx
src/MEDLoader/MEDFileFieldMultiTS.cxx
src/MEDLoader/MEDFileJoint.cxx
src/MEDLoader/MEDFileMesh.cxx
src/MEDLoader/MEDFileMeshElt.cxx
src/MEDLoader/MEDFileMeshLL.cxx
src/MEDLoader/MEDLoader.cxx
src/ParaMEDMEM/CommInterface.hxx
src/ParaMEDMEM/InterpKernelDEC.cxx
src/ParaMEDMEM/InterpKernelDEC.hxx
src/ParaMEDMEM/MPIAccess.cxx
src/ParaMEDMEM/OverlapInterpolationMatrix.cxx
src/ParaMEDMEM/OverlapInterpolationMatrix.hxx
src/ParaMEDMEM/OverlapMapping.cxx
src/ParaMEDMEM/ParaGRID.cxx
src/ParaMEDMEM/ParaGRID.hxx
src/ParaMEDMEM/ParaSkyLineArray.cxx
src/ParaMEDMEMTest/MPI2Connector.cxx
src/ParaMEDMEMTest/ParaMEDMEMTest_ICoco.cxx
src/ParaMEDMEMTest/test_AllToAllTimeDEC.cxx
src/ParaMEDMEMTest/test_AllToAllvTimeDEC.cxx
src/ParaMEDMEMTest/test_AllToAllvTimeDoubleDEC.cxx
src/ParaMEDMEMTest/test_MPI_Access_Cancel.cxx
src/ParaMEDMEMTest/test_MPI_Access_ISendRecv.cxx
src/ParaMEDMEMTest/test_MPI_Access_ISend_IRecv.cxx
src/ParaMEDMEMTest/test_MPI_Access_ISend_IRecv_BottleNeck.cxx
src/ParaMEDMEMTest/test_MPI_Access_ISend_IRecv_Length.cxx
src/ParaMEDMEMTest/test_MPI_Access_ISend_IRecv_Length_1.cxx
src/ParaMEDMEMTest/test_MPI_Access_Time.cxx
src/RENUMBER/RENUMBER_BOOSTRenumbering.cxx

index 7e23b1967ee59a8758423e7b9c3bee78cf5a74b2..3ee1df58f480be75700fe7885f26c480ce90f4c3 100644 (file)
@@ -637,8 +637,7 @@ void GaussInfo::initLocalInfo()
         break;
       }
 
-
-      _my_local_ref_dim = 3;
+/*      _my_local_ref_dim = 3;
       _my_local_nb_ref  = 6;
       penta6aInit();
       aSatify = isSatisfy();
@@ -650,7 +649,7 @@ void GaussInfo::initLocalInfo()
           CHECK_MACRO;
         }
       break;
-
+*/
     case NORM_PENTA15:
       {
         _my_local_ref_dim = 3;
index bd63fe757463a7ddd8e3f9920286ff2db7662af4..6693f5ee9e4f2be75cf4a55e97f22bd4429b1444 100644 (file)
@@ -395,7 +395,6 @@ std::list< IntersectElement > ArcCSegIntersector::getIntersectionsCharacteristic
           // Check tangent vector of the arc circle at the common node with the linear segment.
           // There we can tell if the arc of circle is 'moving away' from the seg, or if it might intersect it twice
           const Node &n(*_earlyInter->getNodeOnly());
-          const double * center(getE1().getCenter());
 
           double tang[2] = {-(n[1]-center[1]), n[0]-center[0]};  // (-y, x) is the tangent vector in the trigo direction with (x,y) = (center->node)
           bool invSeg = _i1S2E || _i1E2E;
index 989419f9dde6739fa241ecbee5f8232941041820..ca7bdac70d66dd55aa41bea27e140b4a233b6bcd 100644 (file)
@@ -27,7 +27,7 @@ using namespace INTERP_KERNEL;
 
 namespace INTERP_KERNEL
 {
-  extern const unsigned MAX_SIZE_OF_LINE_XFIG_FILE=1024;
+  const unsigned MAX_SIZE_OF_LINE_XFIG_FILE=1024;
 }
 
 SegSegIntersector::SegSegIntersector(const EdgeLin& e1, const EdgeLin& e2):
index df1724ac04692ca5e9f6f0a1a308bfb61a0e3ce3..c1a060a4352f0081bb77160f37d11bd7f76c72f9 100644 (file)
@@ -250,8 +250,7 @@ namespace INTERP_KERNEL
             else
               {
                 faceType = cellModelCell.getSonType(ii);
-                const CellModel& faceModel=CellModel::GetCellModel(faceType);
-                assert(faceModel.getDimension() == 2);
+                assert(CellModel::GetCellModel(faceType).getDimension() == 2);
                 nbFaceNodes = cellModelCell.getNumberOfNodesConstituentTheSon(ii);
                 faceNodes = new ConnType[nbFaceNodes];
                 cellModelCell.fillSonCellNodalConnectivity(ii,cellNodes,faceNodes);
@@ -1299,6 +1298,7 @@ namespace INTERP_KERNEL
           default:
             break;
           }
+        break;
 
       case 5: // NORM_PYRA5
         break;
index 5c191a2c1136b5beb85afd0be10a5cb3dafd7cf0..4083addb386e95ccde0fe95cf9d4d91c653d4060 100644 (file)
@@ -80,7 +80,7 @@ namespace INTERP_TEST
       Interpolation3D interpolator;
       interpolator.interpolateMeshes(sMesh_wrapper, tMesh_wrapper,m,"P0P0");
 
-      std::pair<int, int> eff = countNumberOfMatrixEntries(m);
+//      std::pair<int, int> eff = countNumberOfMatrixEntries(m);
 //      LOG(1, eff.first << " of " << numTargetElems * numSrcElems << " intersections calculated : ratio = "
 //          << double(eff.first) / double(numTargetElems * numSrcElems));
       LOG(1, eff.second << " non-zero elements of " << eff.first << " total : filter efficiency = "
index 509032cf5cbd492a1199ebf2a7a5ce8839e4788c..aa75acb9791f4e1414280387e8bbbf4f52d0e9cd 100644 (file)
@@ -1177,7 +1177,6 @@ void QuadraticPlanarInterpTest::checkGetMiddleOfPoints()
     double p2[] = {0.0, 1.0};
     double e_center[] = {-0.71, 2.0};
     double mid[] = {0.0,0.0}; // out
-    double mide[] = {0.0,0.0}; // expected
 
     Node * start = new Node(0.,0.); Node * end = new Node(0.,0.); // unused
     // start, end, center_x, center_y, radius, angle0, angle
index e8b24ac2c7eff55d8ceeb9f6233c3dad0c3123b8..7ef44a4a3c1b67aa1b0f6f6eaa1a57742efc96b4 100644 (file)
@@ -28,8 +28,6 @@ using namespace INTERP_KERNEL;
 
 namespace INTERP_TEST 
 {
-  const double _Epsilon = 1.e-12;
-  const double _Precision = 1.e-12;
   const double _losange1[8] = {   1,0,   0,1,   -1,0,  0,-1 };
   const double _losange2[8] = {   2,0,    1,1,    0,0,  1,-1 };
   const double _losange3[8] = {2.5,0.5,1.5,1.5,0.5,0.5,1.5,-0.5 };
index f029a47669cf41e17aa424b4682ed1b4aef7bfb9..2f7a66e59ab85dfbfb0ac03c1cba30b28772e5e7 100644 (file)
@@ -2302,14 +2302,6 @@ bool MEDCoupling1DGTUMesh::isEqualWithoutConsideringStr(const MEDCouplingMesh *o
   if(!c1->isEqualWithoutConsideringStr(*c2))
     return false;
   return true;
-  c1=_conn_indx; c2=otherC->_conn_indx;
-  if(c1==c2)
-    return true;
-  if(!c1 || !c2)
-    return false;
-  if(!c1->isEqualWithoutConsideringStr(*c2))
-    return false;
-  return true;
 }
 
 /*!
index e5c4a5a2d522a4c128d8e8099e0c7ed5a9fdcef8..c265d7e5f8f5b4dce229cef0507601c9c6113e72 100755 (executable)
@@ -540,6 +540,7 @@ mcIdType MEDCouplingCurveLinearMesh::getCellContainingPoint(const double *pos, d
                 return nodeId;
             }
         }
+      break;
     case 2:
       if(spaceDim==2)
         {
@@ -569,6 +570,7 @@ mcIdType MEDCouplingCurveLinearMesh::getCellContainingPoint(const double *pos, d
                 return nx+ny*_structure[0];
             }
         }
+      break;
     case 3:
       {
         if(spaceDim==3)
@@ -633,9 +635,11 @@ mcIdType MEDCouplingCurveLinearMesh::getCellContainingPoint(const double *pos, d
               }
           }
       }
+      break;
     default:
       throw INTERP_KERNEL::Exception("MEDCouplingCurveLinearMesh::getCellContainingPoint : mesh dimension managed are 1, 2 or 3 !");
   }
+  return 0;
 }
 
 void MEDCouplingCurveLinearMesh::getCellsContainingPoint(const double *pos, double eps, std::vector<mcIdType>& elts) const
index e4e5ea0517550c4af6386014c29a3ddb95b14954..990722c3d702b8b1aab4de6cb98a989b27a2094f 100644 (file)
@@ -213,7 +213,6 @@ MCAuto<DataArrayDouble> MEDCouplingGaussLocalization::localizePtsInRefCooForEach
   double *retPtr(ret->getPointer());
   if(dim!=ToIdType(ptsInRefCoo->getNumberOfComponents()))
     throw INTERP_KERNEL::Exception("MEDCouplingGaussLocalization::localizePtsInRefCooForEachCell : number of components of input coo is not equal to dim of element !");
-  const std::vector<double>& wg(getWeights());
   INTERP_KERNEL::GaussCoords calculator;
   calculator.addGaussInfo(typ,dim, ptsInRefCoo->begin(),nbPts,&_ref_coord[0],getNumberOfPtsInRefCell());
   //
index 0708ee57c1ef5c1fe3b84805ecd3a9593e77293b..3d6cc18f90e1bb68723d4362084c2b4c740add3c 100755 (executable)
@@ -1880,6 +1880,7 @@ DataArrayDouble *DataArrayDouble::cartesianize(MEDCouplingAxisType atOfThis) con
     {
     case AX_CART:
       ret=deepCopy();
+      break;
     case AX_CYL:
       if(nbOfComp==3)
         {
index 14b8b34b7614ec0930e5481d9088a2ae9bd44ad2..a536810981ffd0428c786b6b4ac05e9437d19dcd 100755 (executable)
@@ -5744,7 +5744,6 @@ struct NotInRange
       throw INTERP_KERNEL::Exception("DataArrayInt::indexOfSameConsecutiveValueGroups : only single component allowed !");
     const T *pt(this->begin());
     const T *const ptEnd(this->end()) , * const ptBg(this->begin());
-    const T *oldPt(pt);
     // first find nb of different values in this
     std::size_t nbOfTuplesOut(0);
     while( pt != ptEnd )
index 85f87afe762d8598835d7665976e35a543b4bd4c..ee0bcfba30cfc444b577580efe2e5b258d38af09 100755 (executable)
@@ -217,7 +217,7 @@ bool MEDCouplingPointSet::areCoordsEqualWithoutConsideringStr(const MEDCouplingP
 /*!
  * Returns coordinates of \a nodeId-th node.
  *  \param [in] nodeId - the ID of the node of interest.
- *  \param [in, out] coo - the array filled with coordinates of the \a nodeId-th
+ *  \param [in,out] coo - the array filled with coordinates of the \a nodeId-th
  *         node. This array is not cleared before filling in, the coordinates are
  *         appended to its end.
  *  \throw If the coordinates array is not set.
index 4008627932df51037563862139ea5eb724f9bb9d..7b495a3386a894bd0a675db48226c72152295c56 100755 (executable)
@@ -1144,7 +1144,6 @@ void MEDCouplingRemapper::computeDeno(NatureOfField nat, const MEDCouplingFieldD
 void MEDCouplingRemapper::computeDenoFromScratch(NatureOfField nat, const MEDCouplingFieldDouble *srcField, const MEDCouplingFieldDouble *trgField)
 {
   _nature_of_deno=nat;
-  std::size_t _time_deno_update=getTimeOfThis();
   switch(_nature_of_deno)
   {
     case IntensiveMaximum:
index c022388b4eca168f1658ccf81d41d068cdd9d98a..a890398e76df2b7f2822927b956d4c1d0cc6c2a0 100755 (executable)
@@ -1246,7 +1246,7 @@ bool MEDCouplingUMesh::unPolyze()
       INTERP_KERNEL::NormalizedCellType type=(INTERP_KERNEL::NormalizedCellType)conn[posOfCurCell];
       const INTERP_KERNEL::CellModel& cm=INTERP_KERNEL::CellModel::GetCellModel(type);
       INTERP_KERNEL::NormalizedCellType newType=INTERP_KERNEL::NORM_ERROR;
-      mcIdType newLgth;
+      mcIdType newLgth=0;
       if(cm.isDynamic())
         {
           switch(cm.getDimension())
@@ -1265,11 +1265,12 @@ bool MEDCouplingUMesh::unPolyze()
                 newType=INTERP_KERNEL::CellSimplify::tryToUnPoly3D(zipFullReprOfPolyh,nbOfFaces,lgthOfPolyhConn,conn+newPos+1,newLgth);
                 break;
               }
-            case 1:
+         /*   case 1:  // Not supported yet
               {
                 newType=(lgthOfCurCell==3)?INTERP_KERNEL::NORM_SEG2:INTERP_KERNEL::NORM_POLYL;
                 break;
               }
+         */
           }
           ret=ret || (newType!=type);
           conn[newPos]=newType;
@@ -1663,8 +1664,6 @@ int MEDCouplingUMesh::AreCellsEqualPolicy7(const mcIdType *conn, const mcIdType
                       else
                         return 0;
                     }
-
-                  return work!=tmp+sz1?1:0;
                 }
               else
                 {//case of SEG2 and SEG3
@@ -3337,8 +3336,8 @@ MEDCouplingFieldDouble *MEDCouplingUMesh::getMeasureFieldOnNode(bool isAbs) cons
   mcIdType nbNodes=getNumberOfNodes();
   MCAuto<DataArrayDouble> nnpc;
   {
-    MCAuto<DataArrayIdType> tmp(computeNbOfNodesPerCell());
-    nnpc=tmp->convertToDblArr();
+    MCAuto<DataArrayIdType> tmp2(computeNbOfNodesPerCell());
+    nnpc=tmp2->convertToDblArr();
   }
   std::for_each(nnpc->rwBegin(),nnpc->rwEnd(),[](double& v) { v=1./v; });
   const double *nnpcPtr(nnpc->begin());
index 9cc12330c4cfa90c931ad396c5076243ff7fc372..031a6d5eacf92102d189543f4ae45fe72c7f2c97 100755 (executable)
@@ -1818,7 +1818,7 @@ void MEDCouplingUMesh::attractSeg3MidPtsAroundNodesUnderground(double ratio, con
                       auto ptToMove(nc[*nci+3]);
                       auto attractor(aa?nc[*nci+1]:nc[*nci+2]),endPt(aa?nc[*nci+2]:nc[*nci+1]);
                       std::transform(coords+spaceDim*attractor,coords+spaceDim*(attractor+1),coords+spaceDim*endPt,
-                                     coords+spaceDim*ptToMove,[ratio](const double& stPt, const double& endPt) { return stPt+ratio*(endPt-stPt); });
+                                     coords+spaceDim*ptToMove,[ratio](const double& stPt2, const double& endPt2) { return stPt2+ratio*(endPt2-stPt2); });
                     }
                   else
                     continue;//both 2 boundary nodes of current seg3 are un nodeIds input list -> skip it.
index 0427b166bebbff957c40eb60a06eee8f885ce8b2..d2917ff009037db88ef8a221e173356a2a7f40b6 100644 (file)
@@ -1658,7 +1658,7 @@ void MEDCouplingBasicsTest::test2D1DMeshesIntersection(MEDCouplingUMesh *sourceM
   CPPUNIT_ASSERT_DOUBLES_EQUAL(correctLength, length, prec * std::max(correctLength, length));
 
   INTERP_KERNEL::Interpolation2D3D::DuplicateFacesType duplicateFaces = myInterpolator.retrieveDuplicateFaces();
-  int duplicateFacesNbr = duplicateFaces.size();
+  int duplicateFacesNbr = (int)duplicateFaces.size();
   LOG(1, "duplicateFacesNbr =  " << duplicateFacesNbr <<"  correctDuplicateFacesNbr = " <<  correctDuplicateFacesNbr);
   CPPUNIT_ASSERT_EQUAL(correctDuplicateFacesNbr, duplicateFacesNbr);
 
@@ -1699,7 +1699,7 @@ void MEDCouplingBasicsTest::test3D2DMeshesIntersection(MEDCouplingUMesh *sourceM
     CPPUNIT_ASSERT_DOUBLES_EQUAL(correctSurf, surf, prec * std::max(correctSurf, surf));
 
     INTERP_KERNEL::Interpolation2D3D::DuplicateFacesType duplicateFaces = myInterpolator.retrieveDuplicateFaces();
-    int duplicateFacesNbr = duplicateFaces.size();
+    int duplicateFacesNbr = (int)duplicateFaces.size();
     LOG(1, "duplicateFacesNbr =  " << duplicateFacesNbr <<"  correctDuplicateFacesNbr = " <<  correctDuplicateFacesNbr);
     CPPUNIT_ASSERT_EQUAL(correctDuplicateFacesNbr, duplicateFacesNbr);
 
index 4407bbaae888778d3d264e4b7a56ab64c11e7311..b2a364d348f9041874a4d5907d32b8ea72ff5959 100644 (file)
@@ -18,7 +18,7 @@
 //
 // Author : Anthony Geay (CEA/DEN)
 
-mcIdType connITT[201]={0, 50, 100, 150, 200, 250, 300, 350, 400, 450, 500, 550, 600, 650, 700, 750, 800, 850, 900, 950, 1000, 1029, 1058, 1087, 1116, 1145, 1174, 1203,
+static mcIdType connITT[201]={0, 50, 100, 150, 200, 250, 300, 350, 400, 450, 500, 550, 600, 650, 700, 750, 800, 850, 900, 950, 1000, 1029, 1058, 1087, 1116, 1145, 1174, 1203,
                     1232, 1261, 1290, 1319, 1348, 1377, 1406, 1435, 1464, 1493, 1522, 1551, 1580, 1609, 1638, 1667, 1696, 1725, 1754, 1783, 1812, 1841, 1870, 1899,
                     1928, 1957, 1986, 2015, 2044, 2073, 2102, 2131, 2160, 2189, 2218, 2247, 2276, 2305, 2334, 2363, 2392, 2421, 2450, 2479, 2508, 2537, 2566, 2595,
                     2624, 2653, 2682, 2711, 2740, 2769, 2798, 2827, 2856, 2885, 2914, 2943, 2972, 3001, 3030, 3059, 3088, 3117, 3146, 3175, 3204, 3233, 3262, 3291,
@@ -27,7 +27,7 @@ mcIdType connITT[201]={0, 50, 100, 150, 200, 250, 300, 350, 400, 450, 500, 550,
                     4712, 4741, 4770, 4799, 4828, 4857, 4886, 4915, 4944, 4973, 5002, 5031, 5060, 5089, 5118, 5147, 5176, 5205, 5234, 5263, 5292, 5321, 5350, 5379,
                     5408, 5437, 5466, 5495, 5524, 5553, 5582, 5611, 5640, 5669, 5698, 5727, 5756, 5785, 5814, 5843, 5872, 5901, 5930, 5959, 5988, 6017, 6046, 6075,
                     6104, 6133, 6162, 6191, 6220};
-  mcIdType connTT[6220]={0, 1, 2, 3, 4, 5, 6, -1, 0, 7, 8, 1, -1, 1, 8, 9, 2, -1, 2, 9, 10, 3, -1, 3, 10, 11, 4, -1, 4, 11, 12, 5, -1, 5, 12, 13, 6, -1, 6, 13, 7, 0, -1, 7, 13, 12, 11, 10, 9, 8, 14, 15, 16, 17, 18, 19,
+static mcIdType connTT[6220]={0, 1, 2, 3, 4, 5, 6, -1, 0, 7, 8, 1, -1, 1, 8, 9, 2, -1, 2, 9, 10, 3, -1, 3, 10, 11, 4, -1, 4, 11, 12, 5, -1, 5, 12, 13, 6, -1, 6, 13, 7, 0, -1, 7, 13, 12, 11, 10, 9, 8, 14, 15, 16, 17, 18, 19,
                     20, -1, 14, 21, 22, 15, -1, 15, 22, 23, 16, -1, 16, 23, 24, 17, -1, 17, 24, 25, 18, -1, 18, 25, 26, 19, -1, 19, 26, 27, 20, -1, 20, 27, 21, 14, -1, 21, 27, 26, 25, 24, 23, 22, 28, 29, 30, 31, 32,
                     33, 34, -1, 28, 35, 36, 29, -1, 29, 36, 37, 30, -1, 30, 37, 38, 31, -1, 31, 38, 39, 32, -1, 32, 39, 40, 33, -1, 33, 40, 41, 34, -1, 34, 41, 35, 28, -1, 35, 41, 40, 39, 38, 37, 36, 42, 43, 44, 45,
                     46, 47, 48, -1, 42, 49, 50, 43, -1, 43, 50, 51, 44, -1, 44, 51, 52, 45, -1, 45, 52, 53, 46, -1, 46, 53, 54, 47, -1, 47, 54, 55, 48, -1, 48, 55, 49, 42, -1, 49, 55, 54, 53, 52, 51, 50, 56, 57, 58,
@@ -191,7 +191,7 @@ mcIdType connITT[201]={0, 50, 100, 150, 200, 250, 300, 350, 400, 450, 500, 550,
                     1703, 1699, -1, 1699, 1703, 1700, 1696, -1, 1700, 1703, 1702, 1701, 1704, 1705, 1706, 1707, -1, 1704, 1708, 1709, 1705, -1, 1705, 1709, 1710, 1706, -1, 1706, 1710, 1711, 1707, -1, 1707, 1711,
                     1708, 1704, -1, 1708, 1711, 1710, 1709, 1712, 1713, 1714, 1715, -1, 1712, 1716, 1717, 1713, -1, 1713, 1717, 1718, 1714, -1, 1714, 1718, 1719, 1715, -1, 1715, 1719, 1716, 1712, -1, 1716, 1719, 1718, 1717};
 
-double coordsTT[5160]={
+static double coordsTT[5160]={
     0.0054015000000000044, 0.0054015000000000053, 0, 0.2106585, 0.0054015000000000053, 0, 0.2106585, 0.039611, 0, 0.2106585, 0.10803, 0, 0.2106585,
     0.17644899999999999, 0, 0.2106585, 0.2106585, 0, 0.0054015000000000044, 0.2106585, 0, 0.0054015000000000044, 0.0054015000000000053, 0.21364999999999998,
     0.2106585, 0.0054015000000000053, 0.21364999999999998, 0.2106585, 0.039611, 0.21364999999999998, 0.2106585, 0.10803, 0.21364999999999998, 0.2106585,
@@ -906,7 +906,7 @@ double coordsTT[5160]={
   };
 
 
-const mcIdType connTFH8[2560]={
+static const mcIdType connTFH8[2560]={
   1, 2, 7, 6, 28, 29, 34, 33, 2, 3, 8, 7, 29, 30, 35, 34, 3, 4, 9, 8, 30, 31, 36, 35, 4, 5, 10, 9, 31, 32, 37, 36, 6, 7, 12, 11, 33, 34, 39, 38, 7, 8, 13, 12, 34, 35, 40, 39,
   8, 9, 14, 13, 35, 36, 41, 40, 9, 10, 15, 14, 36, 37, 42, 41, 11, 12, 17, 16, 38, 39, 44, 43, 12, 13, 18, 17, 39, 40, 45, 44, 13, 14, 19, 18, 40, 41, 46, 45, 14, 15, 20, 19,
   41, 42, 47, 46, 16, 17, 21, 26, 43, 44, 48, 53, 17, 18, 22, 21, 44, 45, 49, 48, 18, 19, 23, 22, 45, 46, 50, 49, 19, 20, 24, 23, 46, 47, 51, 50, 28, 29, 34, 33, 55, 56, 61, 60,
@@ -966,7 +966,7 @@ const mcIdType connTFH8[2560]={
   526, 531, 530, 552, 553, 558, 557, 526, 527, 532, 531, 553, 554, 559, 558, 527, 528, 533, 532, 554, 555, 560, 559, 529, 530, 534, 539, 556, 557, 561, 566, 530, 531, 535, 534, 557, 558, 562, 561, 531, 532, 536, 535, 558, 559, 563,
   562, 532, 533, 537, 536, 559, 560, 564, 563};
 
-const mcIdType connTFPOLH[1000]={
+static const mcIdType connTFPOLH[1000]={
   0, 25, 26, 16, 11, 6, 1, -1, 27, 28, 33, 38, 43, 53, 52, -1, 0, 1, 28, 27, -1, 1, 6, 33, 28, -1, 6, 11, 38, 33, -1, 11, 16, 43, 38, -1, 16, 26, 53, 43, -1, 26, 25, 52, 53, -1, 25, 0, 27, 52, 27, 52, 53, 43, 38, 33, 28, -1, 54, 55,
   60, 65, 70, 80, 79, -1, 27, 28, 55, 54, -1, 28, 33, 60, 55, -1, 33, 38, 65, 60, -1, 38, 43, 70, 65, -1, 43, 53, 80, 70, -1, 53, 52, 79, 80, -1, 52, 27, 54, 79, 54, 79, 80, 70, 65, 60, 55, -1, 81, 82, 87, 92, 97, 107, 106, -1, 54,
   55, 82, 81, -1, 55, 60, 87, 82, -1, 60, 65, 92, 87, -1, 65, 70, 97, 92, -1, 70, 80, 107, 97, -1, 80, 79, 106, 107, -1, 79, 54, 81, 106, 81, 106, 107, 97, 92, 87, 82, -1, 108, 109, 114, 119, 124, 134, 133, -1, 81, 82, 109, 108, -1,
@@ -989,7 +989,7 @@ const mcIdType connTFPOLH[1000]={
   538, 539, 529, 524, 519, 514, -1, 540, 541, 546, 551, 556, 566, 565, -1, 513, 514, 541, 540, -1, 514, 519, 546, 541, -1, 519, 524, 551, 546, -1, 524, 529, 556, 551, -1, 529, 539, 566, 556, -1, 539, 538, 565, 566, -1, 538, 513, 540, 565
 };
 
-const double coordsTF[1701]={
+static const double coordsTF[1701]={
   0, 0, 0, 0.21606, 0, 0, 0.25207000000000002, 0, 0, 0.32408999999999999, 0, 0, 0.39610999999999996, 0, 0, 0.43212, 0, 0, 0.21606, 0.03601, 0,
   0.25207000000000002, 0.03601, 0, 0.32408999999999999, 0.03601, 0, 0.39610999999999996, 0.03601, 0, 0.43212, 0.03601, 0, 0.21606, 0.10803, 0, 0.25207000000000002,
   0.10803, 0, 0.32408999999999999, 0.10803, 0, 0.39610999999999996, 0.10803, 0, 0.43212, 0.10803, 0, 0.21606, 0.18004999999999999, 0, 0.25207000000000002,
@@ -1164,4 +1164,4 @@ const double coordsTF[1701]={
   4.2729999999999997, 0, 0.21606, 4.2729999999999997, 0.21606, 0.21606, 4.2729999999999997
 };
 
-const mcIdType connTFPOLH_I[21]={0, 50, 100, 150, 200, 250, 300, 350, 400, 450, 500, 550, 600, 650, 700, 750, 800, 850, 900, 950, 1000};
+static const mcIdType connTFPOLH_I[21]={0, 50, 100, 150, 200, 250, 300, 350, 400, 450, 500, 550, 600, 650, 700, 750, 800, 850, 900, 950, 1000};
index 036565cdc8186175a6949d1f840d37f648a97eef..e2e9c2914b102376bc022b0ad0e3eb2f9a85b1f8 100644 (file)
@@ -143,7 +143,7 @@ void CppExample_MEDCouplingFieldDouble_substractInPlaceDM()
     mesh1->fillFromAnalytic( MEDCoupling::ON_NODES,1,"x"); // field1 values == coords1
   MCAuto<MEDCouplingFieldDouble> field2 =
     mesh2->fillFromAnalytic( MEDCoupling::ON_NODES,1,"x"); // field2 values == coords2
-  const double levOfCheck = 10; // nodes can be permuted
+  const int levOfCheck = 10; // nodes can be permuted
   field1->substractInPlaceDM( field2, levOfCheck, 1e-13, 0 ); // values #0 and #2 must swap
   //! [CppSnippet_MEDCouplingFieldDouble_substractInPlaceDM_2]
   //! [CppSnippet_MEDCouplingFieldDouble_substractInPlaceDM_3]
@@ -174,7 +174,7 @@ void CppExample_MEDCouplingFieldDouble_changeUnderlyingMesh()
   //! [CppSnippet_MEDCouplingFieldDouble_changeUnderlyingMesh_2]
   MCAuto<MEDCouplingFieldDouble> field =
     mesh1->fillFromAnalytic( MEDCoupling::ON_NODES,1,"x"); // field values == coords1
-  const double levOfCheck = 10; // nodes can be permuted
+  const int levOfCheck = 10; // nodes can be permuted
   field->changeUnderlyingMesh( mesh2, levOfCheck, 1e-13, 0 ); // values #0 and #2 must swap
   CPPUNIT_ASSERT( std::equal( coords2, coords2+4, field->getArray()->getConstPointer() ));
   //! [CppSnippet_MEDCouplingFieldDouble_changeUnderlyingMesh_2]
index a3f52dec04eb41ef88401fdcf2cc1a2c1260862a..8fb267b853eec982b85aa780ed12e3d0de064213 100644 (file)
@@ -2044,7 +2044,7 @@ static void convertObjToPossibleCpp6(PyObject *value, mcIdType& sw, char& cTyp,
             {
               vsType[i]=convertPyObjectToStr(o);
             }
-          catch(INTERP_KERNEL::Exception& e)
+          catch(INTERP_KERNEL::Exception& )
             {
               std::ostringstream oss; oss << "Tuple as been detected but element #" << i << " is not a string ! only tuples of strings accepted !";
               throw INTERP_KERNEL::Exception(oss.str().c_str());
@@ -2064,7 +2064,7 @@ static void convertObjToPossibleCpp6(PyObject *value, mcIdType& sw, char& cTyp,
             {
               vsType[i]=convertPyObjectToStr(o);
             }
-          catch(INTERP_KERNEL::Exception& e)
+          catch(INTERP_KERNEL::Exception& )
             {
               std::ostringstream oss; oss << "List as been detected but element #" << i << " is not a string ! only tuples of strings accepted !";
               throw INTERP_KERNEL::Exception(oss.str().c_str());
index f773a32ea00f97e0489f6f665dc1b816e7cdfca0..29dd40c0dc0613baad99c00668348afb17159877 100644 (file)
@@ -462,7 +462,7 @@ MCAuto<DataArrayDouble> LocInfo::BuildMeshFromEpaisseur(INTERP_KERNEL::Normalize
 {
   MCAuto<DataArrayDouble> ptsForLoc;
   MCAuto<MEDCouplingUMesh> geoMesh(BuildMeshCommon(gt,pfl,loc,zeStr,mesh,section,globs,ptsForLoc));
-  mcIdType nbSecPts(section->getNumberOfNodes()),nbCells(geoMesh->getNumberOfCells()),nbg(ToIdType(loc.getGaussWeights().size()));
+  mcIdType nbCells(geoMesh->getNumberOfCells()),nbg(ToIdType(loc.getGaussWeights().size()));
   MCConstAuto<DataArrayDouble> zeThickness;
   if(!pfl.empty())
     {
index 5e3489d19c1f450c60fc18a5159f12052f4e763c..cf9523f5939b4a68cd021f16ef47113b1630ed2f 100644 (file)
@@ -26,6 +26,7 @@
 #include "MEDFileMesh.hxx"
 #include "InterpKernelAutoPtr.hxx"
 
+// From MEDLOader.cxx TU
 extern med_geometry_type typmai[MED_N_CELL_FIXED_GEO];
 extern INTERP_KERNEL::NormalizedCellType typmai2[MED_N_CELL_FIXED_GEO];
 extern med_geometry_type typmai3[INTERP_KERNEL::NORM_MAXTYPE];
index 4cfee0c64d2d9bb8f0a4a6d673fb41211b99ec96..99ac6bb880083d22912064ccc02afe585c726916 100644 (file)
@@ -35,6 +35,7 @@
 #include <algorithm>
 #include <iterator>
 
+// From MEDLoader.cxx TU:
 extern INTERP_KERNEL::NormalizedCellType typmai2[MED_N_CELL_FIXED_GEO];
 extern med_geometry_type typmainoeud[1];
 extern med_geometry_type typmai3[INTERP_KERNEL::NORM_MAXTYPE];
@@ -234,7 +235,7 @@ void MEDFileFields::simpleRepr(int bkOffset, std::ostream& oss) const
   for(std::vector< MCAuto<MEDFileAnyTypeFieldMultiTSWithoutSDA> >::const_iterator it=_fields.begin();it!=_fields.end();it++,i++)
     {
       const MEDFileAnyTypeFieldMultiTSWithoutSDA *cur=(*it);
-      std::string chapter(17,'0'+i);
+      std::string chapter(17,(char)('0'+i));
       oss << startLine << chapter << std::endl;
       if(cur)
         {
index aa655de53ea00e7d6b9246e9231e486e0f5dea4a..8eea653c6342f199208991c630527805178ec2e2 100644 (file)
@@ -1258,6 +1258,7 @@ MEDCouplingFieldDouble *MEDFileAnyTypeField1TSWithoutSDA::getFieldOnMeshAtLevel(
         if(renumPol==1)
           return ret.retn();
       }
+      [[clang::fallthrough]];  // yes no break here - silence clang warning.
     case 2:
       {
         //no need to test _field_per_mesh.empty() because geMeshName has already done it
@@ -1278,9 +1279,11 @@ MEDCouplingFieldDouble *MEDFileAnyTypeField1TSWithoutSDA::getFieldOnMeshAtLevel(
           }
         return ret.retn();
       }
+      break;
     default:
       throw INTERP_KERNEL::Exception("MEDFileField1TSWithoutSDA::getFieldOnMeshAtLevel : unsupported renum policy ! Dealing with policy 0 1 2 and 3 !");
   }
+  return nullptr;
 }
 
 /*!
@@ -2028,13 +2031,6 @@ int MEDFileAnyTypeField1TS::LocateField2(med_idt fid, int fieldIdCFormat, bool c
 /*!
  * This method throws an INTERP_KERNEL::Exception if \a fieldName field is not in file pointed by \a fid and with name \a fileName.
  * 
- * \param [in] fid - MED file handler
- * \param [in] fieldName - name of the field
- * \param [out] posCFormat - index of the field in the file(?)
- * \param [out] typcha - type of the field
- * \param [out] infos - informations on the field
- * \param [out] dtunitOut - time unit description
- * \param [out] meshName - name of the mesh supporting the field
  * \return in case of success the number of time steps available for the field with name \a fieldName.
  */
 int MEDFileAnyTypeField1TS::LocateField(med_idt fid, const std::string& fieldName, int& posCFormat, med_field_type& typcha, std::vector<std::string>& infos, std::string& dtunitOut, std::string& meshName)
index 13688cddceca721fded3a4a72f45e3245a81c355..ec65b2c32ab036b0558dc228a1aaaf5b526ff9b4 100644 (file)
@@ -32,6 +32,7 @@
 
 #include "CellModel.hxx"
 
+// From MEDLOader.cxx TU
 extern med_geometry_type typmai[MED_N_CELL_FIXED_GEO];
 extern INTERP_KERNEL::NormalizedCellType typmai2[MED_N_CELL_FIXED_GEO];
 extern med_geometry_type typmai3[INTERP_KERNEL::NORM_MAXTYPE];
@@ -908,8 +909,6 @@ void MEDFileFieldPerMeshPerTypePerDisc::fillValues(int discId, mcIdType& startEn
 
 void MEDFileFieldPerMeshPerTypePerDisc::writeLL(med_idt fid, const MEDFileFieldNameScope& nasc) const
 {
-  TypeOfField type=getType();
-  INTERP_KERNEL::NormalizedCellType geoType(getGeoType());
   med_geometry_type mgeoti;
   med_entity_type menti;
   _father->entriesForMEDfile(getType(),mgeoti,menti);
index 688e7fd6bef23423ebaebead6f73bf42414ed297..3d143bd322833f4f373b5606e210b6c374d038d7 100644 (file)
@@ -414,7 +414,7 @@ void MEDFileAnyTypeFieldMultiTSWithoutSDA::simpleRepr(int bkOffset, std::ostream
   int i=0;
   for(std::vector< MCAuto<MEDFileAnyTypeField1TSWithoutSDA> >::const_iterator it=_time_steps.begin();it!=_time_steps.end();it++,i++)
     {
-      std::string chapter(17,'0'+i);
+      std::string chapter(17,(char)('0'+i));
       oss << startLine << chapter << std::endl;
       const MEDFileAnyTypeField1TSWithoutSDA *cur=(*it);
       if(cur)
index 7565e06036a6dcd25c305b676dc394884b790ae6..2736504bf60165aaee7984b3a9f2921a6e9aca81 100644 (file)
 #include "CellModel.hxx"
 #include "InterpKernelAutoPtr.hxx"
 
-extern med_geometry_type                 typmai[MED_N_CELL_FIXED_GEO];
-extern INTERP_KERNEL::NormalizedCellType typmai2[MED_N_CELL_FIXED_GEO];
-extern med_geometry_type                 typmai3[INTERP_KERNEL::NORM_MAXTYPE];
+// From MEDLOader.cxx TU
+extern const med_geometry_type                 typmai[MED_N_CELL_FIXED_GEO];
+extern const INTERP_KERNEL::NormalizedCellType typmai2[MED_N_CELL_FIXED_GEO];
+extern const med_geometry_type                 typmai3[INTERP_KERNEL::NORM_MAXTYPE];
 
 using namespace MEDCoupling;
 
index 193e068b95f7a34ceb15fa276986918a1e141b39..076c7c1776044156b20fb9787b48b4dc350f65bc 100644 (file)
@@ -35,6 +35,7 @@
 #include <limits>
 #include <cmath>
 
+// From MEDLOader.cxx TU
 extern med_geometry_type                 typmai[MED_N_CELL_FIXED_GEO];
 extern INTERP_KERNEL::NormalizedCellType typmai2[MED_N_CELL_FIXED_GEO];
 extern med_geometry_type typmai3[INTERP_KERNEL::NORM_MAXTYPE];
@@ -695,10 +696,10 @@ void MEDFileMesh::removeGroupAtLevel(int meshDimRelToMaxExt, const std::string&
   if(idsToKill->empty())
     return ;
   std::vector<std::string> newFamsOnGrp;
-  for(std::vector<std::string>::const_iterator it=famsOnGrp.begin();it!=famsOnGrp.end();it++)
+  for(std::vector<std::string>::const_iterator itt=famsOnGrp.begin();itt!=famsOnGrp.end();itt++)
     {
-      if(!idsToKill->presenceOfValue(getFamilyId(*it)))
-         newFamsOnGrp.push_back(*it);
+      if(!idsToKill->presenceOfValue(getFamilyId(*itt)))
+         newFamsOnGrp.push_back(*itt);
     }
   (*it).second=newFamsOnGrp;
 }
@@ -859,7 +860,7 @@ void MEDFileMesh::rearrangeFamilies()
       {
           fams=getFamilyFieldAtLevel(*it);
       }
-      catch(INTERP_KERNEL::Exception& e) { }
+      catch(INTERP_KERNEL::Exception& ) { }
       if(!fams)
         continue;
       std::vector<bool> v(fams->getNumberOfTuples(),false);
@@ -942,7 +943,7 @@ void MEDFileMesh::zipFamilies()
             {
               fams=getFamilyFieldAtLevel(*it);
             }
-          catch(INTERP_KERNEL::Exception& e) { }
+          catch(INTERP_KERNEL::Exception& ) { }
           if(!fams)
             continue;
           MCAuto<DataArrayIdType> idsToModif(fams->findIdsEqualList(famIdsSubstSession.second.data(),famIdsSubstSession.second.data()+famIdsSubstSession.second.size()));
@@ -6060,6 +6061,7 @@ void MEDFileStructuredMesh::setNameFieldAtLevel(int meshDimRelToMaxExt, DataArra
         mcIdType nbCells=mesh->getNumberOfCellsOfSubLevelMesh();
         nameArr->checkNbOfTuplesAndComp(nbCells,MED_SNAME_SIZE,"MEDFileStructuredMesh::setNameFieldAtLevel : Problem in size of names arr ! Mismatch with number of faces of mesh !");
         _names_faces=nameArr;
+        break;
       }
     default:
       throw INTERP_KERNEL::Exception("MEDFileStructuredMesh::setNameFieldAtLevel : Only available for levels 0 or 1 or -1 !");
index eb755f964f62c4d499f2920102d3d44a07b4e746..9a274cd7c97deae3a383e438ba70bd7412d80bdc 100644 (file)
@@ -31,6 +31,7 @@
 
 #include <iostream>
 
+// From MEDLOader.cxx TU
 extern med_geometry_type typmai3[INTERP_KERNEL::NORM_MAXTYPE];
 
 using namespace MEDCoupling;
index 72f4486e5d0f4d47e80c4cd4a648c98851e13e47..733d7e2b376368b52dc5de881e52de1f57280ab0 100644 (file)
@@ -34,6 +34,7 @@
 #include <set>
 #include <iomanip>
 
+// From MEDLOader.cxx TU
 extern med_geometry_type typmai[MED_N_CELL_FIXED_GEO];
 extern INTERP_KERNEL::NormalizedCellType typmai2[MED_N_CELL_FIXED_GEO];
 extern med_geometry_type typmainoeud[1];
@@ -298,10 +299,10 @@ void MEDFileMeshL2::ReadFamiliesAndGrps(med_idt fid, const std::string& meshName
       INTERP_KERNEL::AutoPtr<char> gro=new char[MED_LNAME_SIZE*ngro+1];
       MEDfamily23Info(fid,meshName.c_str(),i+1,nomfam,attide,attval,attdes,&numfam,gro);
       std::string famName(MEDLoaderBase::buildStringFromFortran(nomfam,MED_NAME_SIZE));
-      std::vector<std::string> grps(ngro);
+      std::vector<std::string> grps2(ngro);
       for(int j=0;j<ngro;j++)
-        grps[j]=MEDLoaderBase::buildStringFromFortran(gro+j*MED_LNAME_SIZE,MED_LNAME_SIZE);
-      crudeFams[i]=std::pair<std::string,std::pair<mcIdType,std::vector<std::string> > >(famName,std::pair<mcIdType,std::vector<std::string> >(numfam,grps));
+        grps2[j]=MEDLoaderBase::buildStringFromFortran(gro+j*MED_LNAME_SIZE,MED_LNAME_SIZE);
+      crudeFams[i]=std::pair<std::string,std::pair<mcIdType,std::vector<std::string> > >(famName,std::pair<mcIdType,std::vector<std::string> >(numfam,grps2));
     }
   RenameFamiliesFromFileToMemInternal(crudeFams);
   for(std::vector< std::pair<std::string,std::pair<mcIdType,std::vector<std::string> > > >::const_iterator it0=crudeFams.begin();it0!=crudeFams.end();it0++)
index 4899e483c8b4afb24feb565272b189328084efab..eee04129a6ea7af2db49b723afe828715dc68c2b 100644 (file)
 #include <algorithm>
 #include <memory>
 
+extern med_geometry_type typmai[MED_N_CELL_FIXED_GEO];
+extern med_geometry_type typmainoeud[1];
+extern INTERP_KERNEL::NormalizedCellType typmai2[MED_N_CELL_FIXED_GEO];
+extern med_geometry_type typmai3[INTERP_KERNEL::NORM_MAXTYPE];
+
+
 med_geometry_type typmai[MED_N_CELL_FIXED_GEO] = { MED_POINT1,
   MED_SEG2,
   MED_SEG3,
@@ -136,11 +142,11 @@ med_geometry_type typmai3[INTERP_KERNEL::NORM_MAXTYPE] = { MED_POINT1,//0
   MED_POLYGON2//32
 };
 
-double _EPS_FOR_NODE_COMP=1.e-12;
-
-int _COMP_FOR_CELL=0;
+// Just for this translation unit:
+static double _EPS_FOR_NODE_COMP=1.e-12;
+static int _COMP_FOR_CELL=0;
+static int _TOO_LONG_STR=0;
 
-int _TOO_LONG_STR=0;
 
 using namespace MEDCoupling;
 
index 6671c97030d2069340f36600da602d2822e33224..6cdf1bfce0107dac032167d1c2bcd356c80c4db9 100644 (file)
@@ -164,7 +164,6 @@ namespace MEDCoupling
     template<class T>
     int gatherArraysT(MPI_Comm comm, int root, const typename Traits<T>::ArrayType *array, std::unique_ptr<T[]>& result, std::unique_ptr<mcIdType[]>& resultIndex, int& rank) const
     {
-      using DataArrayT = typename Traits<T>::ArrayType;
       int size;
       this->commSize(comm,&size);
       rank = -1;
@@ -214,7 +213,6 @@ namespace MEDCoupling
     template<class T>
     int allGatherArraysT(MPI_Comm comm, const typename Traits<T>::ArrayType *array, std::unique_ptr<T[]>& result, std::unique_ptr<mcIdType[]>& resultIndex) const
     {
-      using DataArrayT = typename Traits<T>::ArrayType;
       int size;
       this->commSize(comm,&size);
       std::unique_ptr<mcIdType[]> nbOfElems(new mcIdType[size]);
index afdb821f8baea0f6c05a04e359dc4208b2422a22..d379bf206c9efe4fc088d76e7a24351890441746 100644 (file)
@@ -34,8 +34,7 @@ namespace MEDCoupling
 {
   InterpKernelDEC::InterpKernelDEC():
     DisjointDEC(),
-    _nb_distant_points(0), _distant_coords(0),
-    _distant_locations(0), _interpolation_matrix(0)
+    _interpolation_matrix(0)
   {  
   }
 
@@ -52,8 +51,7 @@ namespace MEDCoupling
   */
   InterpKernelDEC::InterpKernelDEC(ProcessorGroup& source_group, ProcessorGroup& target_group):
     DisjointDEC(source_group, target_group),
-    _nb_distant_points(0), _distant_coords(0),
-    _distant_locations(0), _interpolation_matrix(0)
+    _interpolation_matrix(0)
   {
 
   }
@@ -67,8 +65,7 @@ namespace MEDCoupling
   InterpKernelDEC::InterpKernelDEC(const std::set<int>& src_ids, const std::set<int>& trg_ids,
                                    const MPI_Comm& world_comm):
     DisjointDEC(src_ids,trg_ids,world_comm),
-    _nb_distant_points(0), _distant_coords(0),
-    _distant_locations(0), _interpolation_matrix(0)
+    _interpolation_matrix(0)
   {
   }
 
index 4e697619829c776ef12f79eb64dc6a8c9e259a48..b92a663c8c5f7aa57f3e7119c17a8286a64dfbf4 100644 (file)
@@ -141,12 +141,6 @@ namespace MEDCoupling
     void prepareSourceDE() { }
     void prepareTargetDE() { }
   private :
-    //Number of distant points to be located locally 
-    int _nb_distant_points;
-    //coordinates of distant points 
-    const double* _distant_coords;
-    //local element number containing the distant points  
-    const int* _distant_locations; 
     InterpolationMatrix* _interpolation_matrix;
   };
 }
index 55ea1baf52d9cf82334f94f51b17d8c1e98b8e5e..8ddaf698c2779ae943ae2895335c4b85535f1135 100644 (file)
@@ -407,8 +407,8 @@ namespace MEDCoupling
         int outcount = 0 ;
         if ( sts == MPI_SUCCESS )
           {
-            MPI_Datatype datatype = MPIDatatype( RequestId ) ;
-            _comm_interface.getCount(MPIStatus( RequestId ), datatype, &outcount ) ;
+            MPI_Datatype datatype2 = MPIDatatype( RequestId ) ;
+            _comm_interface.getCount(MPIStatus( RequestId ), datatype2, &outcount ) ;
             setMPIOutCount( RequestId , outcount ) ;
             setMPICompleted( RequestId , true ) ;
             deleteStatus( RequestId ) ;
index 1f81887cae80dd6f83a0cc68c55690e8f8e9fcaf..9ec73fd230359feaeed65e238379a308c7a30dd5 100644 (file)
@@ -56,8 +56,7 @@ namespace MEDCoupling
     _target_field(target_field),
     _source_support(source_field->getSupport()->getCellMesh()),
     _target_support(target_field->getSupport()->getCellMesh()),
-    _mapping(group, locator),
-    _group(group)
+    _mapping(group, locator)
   {
   }
 
index 1d89bf8593e599b922687198f5b6ff467345bb91..d884f963df093d633c1899344a801484b2360b6f 100644 (file)
@@ -74,8 +74,6 @@ namespace MEDCoupling
     MEDCouplingPointSet *_source_support;
     MEDCouplingPointSet *_target_support;
     OverlapMapping      _mapping;
-    const ProcessorGroup& _group;
   };
 }
 
index bf25a6636ca7424b47e62dd2ef544f17153581cc..4fe0b6f89107630cdf962a53a7fc25054ccc5a5b 100644 (file)
@@ -279,10 +279,10 @@ void OverlapMapping::computeDenoConservativeVolumic(mcIdType nbOfTuplesTrg)
       denoM.resize(mat.size());
       if(isItem1==_sent_trg_ids.end() || curSrcId==myProcId)//item1 of step2 main algo. Simple, because rowId of mat are directly target ids.
         {
-          mcIdType rowId=0;
-          for(std::vector< SparseDoubleVec >::const_iterator it1=mat.begin();it1!=mat.end();it1++,rowId++)
+          mcIdType rowId2=0;
+          for(std::vector< SparseDoubleVec >::const_iterator it1=mat.begin();it1!=mat.end();it1++,rowId2++)
             for(SparseDoubleVec::const_iterator it2=(*it1).begin();it2!=(*it1).end();it2++)
-              denoM[rowId][(*it2).first]=deno[rowId];
+              denoM[rowId2][(*it2).first]=deno[rowId2];
         }
       else
         {
index 5dbb2323de1a81472d24f01532d8ebf7a524271b..4928682c86a924b78a9688329cf96acaf3760b24 100644 (file)
@@ -32,7 +32,7 @@ namespace MEDCoupling
 {
   
   ParaGRID::ParaGRID(MEDCouplingCMesh* global_grid, Topology* topology) : 
-    _global_axis(), _my_domain_id(0)
+    _global_axis()
   {
     _block_topology = dynamic_cast<BlockTopology*>(topology);
     if(_block_topology==0)
index a5e7e7a7dbbeb4faa5d333e0b7fcb09657ca23a4..57c7afa0ebac43e91f8d961c1459e13cce8308cb 100644 (file)
@@ -47,8 +47,6 @@ namespace MEDCoupling
     MEDCoupling::BlockTopology* _block_topology;
     // stores the x,y,z axes on the global grid
     std::vector<std::vector<double> > _global_axis;
-    //id of the local grid
-    int _my_domain_id;
   };
 }
 
index 586c0c4a85e8041d13926369788e8c66000a6781..4ae9e87652057a7eadd2483652185fe1593caaf3 100644 (file)
@@ -132,4 +132,5 @@ MCAuto<ParaSkyLineArray> ParaSkyLineArray::equiRedistribute(mcIdType nbOfEntitie
   skOut = skOut->uniqueNotSortedByPack();//remove duplicates
   MCAuto<ParaSkyLineArray> ret(ParaSkyLineArray::New(skOut,globalIdsOut));
   return ret.retn();
-}
\ No newline at end of file
+}
+
index 87b16bfb24419b64d54e43f132831ec307c57f70..a8a5bc432e3264d32cac33556811a16778bb5518 100644 (file)
 #include <unistd.h>
 #endif
 
-#if OMPI_MAJOR_VERSION >= 4
-#define MPI_ERROR_HANDLER(var) MPI_Comm_set_errhandler(MPI_COMM_WORLD, var);
-#else
-#define MPI_ERROR_HANDLER(var) MPI_Errhandler_set(MPI_COMM_WORLD, var);
+
+#ifdef OMPI_MAJOR_VERSION 
+#   if OMPI_MAJOR_VERSION >= 4
+#      define MPI_ERROR_HANDLER(var) MPI_Comm_set_errhandler(MPI_COMM_WORLD, var);
+#   endif
+#else  // MPICH and other versions:
+#   define MPI_ERROR_HANDLER(var) MPI_Errhandler_set(MPI_COMM_WORLD, var);
 #endif
 
 MPI2Connector::MPI2Connector()
index 3a489e478913f58dff269887d449246a701e66ae..2650ce9ef296c798711f223db9491d32e20c01ea 100644 (file)
@@ -45,7 +45,7 @@ void synchronize_bool(bool& stop, synctype s)
   int my_stop_temp = stop?1:0;
   if (s==sync_and)
     MPI_Allreduce(&my_stop_temp,&my_stop,1,MPI_INTEGER,MPI_MIN,MPI_COMM_WORLD);
-  else if (s==sync_or)
+  else // if (s==sync_or)
     MPI_Allreduce(&my_stop_temp,&my_stop,1,MPI_INTEGER,MPI_MAX,MPI_COMM_WORLD);
   stop =(my_stop==1);
 }
index c365cc203eef11611a0268d6d92de8f4283c68d3..b43e1bd66b529bf650ad145da6afacdbf0d3f713 100644 (file)
@@ -152,7 +152,7 @@ void MPIAccessDECTest::test_AllToAllTimeDEC( bool Asynchronous ) {
       recvbuf[j] = -1 ;
     }
 
-    int sts = MyMPIAccessDEC->allToAllTime( sendbuf, sendcount , MPI_INT ,
+    sts = MyMPIAccessDEC->allToAllTime( sendbuf, sendcount , MPI_INT ,
                                             recvbuf, recvcount , MPI_INT ) ;
     chksts( sts , myrank , mpi_access ) ;
 
index 4af2ead7454ee9262c3a8a340ce3266d8348a26c..a35a1117a1e871e1b763f95a6350412ef1bf60b8 100644 (file)
@@ -210,9 +210,9 @@ void MPIAccessDECTest::test_AllToAllvTimeDEC( bool Asynchronous , bool UseMPINat
       delete [] sendbuf ;
     }
     else {
-      int sts = MyMPIAccessDEC->allToAllvTime( sendbuf, sendcounts , sdispls , MPI_INT ,
+      int sts2 = MyMPIAccessDEC->allToAllvTime( sendbuf, sendcounts , sdispls , MPI_INT ,
                                                recvbuf, recvcounts , rdispls , MPI_INT ) ;
-      chksts( sts , myrank , mpi_access ) ;
+      chksts( sts2 , myrank , mpi_access ) ;
     }
 
     //     debugStream << "test_AllToAllvTimeDEC" << myrank << " recvbuf before CheckSent" ;
@@ -242,10 +242,9 @@ void MPIAccessDECTest::test_AllToAllvTimeDEC( bool Asynchronous , bool UseMPINat
     //     debugStream << "test_AllToAllvTimeDEC" << myrank << " check of recvbuf" << endl ;
     bool badrecvbuf = false ;
     for ( i = 0 ; i < size ; i++ ) {
-      int j ;
-      for ( j = 0 ; j < datamsglength ; j++ ) {
-        int index = i*datamsglength+j ;
-        if ( j < recvcounts[i] ) {
+      for ( int jj = 0 ; jj < datamsglength ; jj++ ) {
+        int index = i*datamsglength+jj ;
+        if ( jj < recvcounts[i] ) {
           if ( recvbuf[index] != (index/datamsglength)*1000000 + myrank*1000 +
                myrank*datamsglength+(index%datamsglength) ) {
             badrecvbuf = true ;
index d15a81b16834b27f250b0cc795013f6da18b8ff7..ead0f9caa2dccf39f871ed07371246ae617a35b4 100644 (file)
@@ -189,7 +189,7 @@ void MPIAccessDECTest::test_AllToAllvTimeDoubleDEC( bool Asynchronous ) {
         //debugStream << endl ;
      }
 
-     int sts = MyMPIAccessDEC->allToAllvTime( sendbuf, sendcounts , sdispls , MPI_DOUBLE ,
+     sts = MyMPIAccessDEC->allToAllvTime( sendbuf, sendcounts , sdispls , MPI_DOUBLE ,
                                             recvbuf, recvcounts , rdispls , MPI_DOUBLE ) ;
      chksts( sts , myrank , mpi_access ) ;
 
@@ -218,23 +218,22 @@ void MPIAccessDECTest::test_AllToAllvTimeDoubleDEC( bool Asynchronous ) {
 //     debugStream << "test_AllToAllvTimeDoubleDEC" << myrank << " check of recvbuf" << endl ;
      bool badrecvbuf = false ;
      for ( target = 0 ; target < size ; target++ ) {
-        int j ;
-        for ( j = 0 ; j < datamsglength ; j++ ) {
-           int index = target*datamsglength+j ;
-           if ( j < recvcounts[target] ) {
+        for ( int jj = 0 ; jj < datamsglength ; jj++ ) {
+           int index = target*datamsglength+jj ;
+           if ( jj < recvcounts[target] ) {
              if ( fabs(recvbuf[index] - (target*1000000 + myrank*10000 +
-                  (timeLoc[target]/deltatime[target])*100 + j)) > 101) {
+                  (timeLoc[target]/deltatime[target])*100 + jj)) > 101) {
                badrecvbuf = true ;
                debugStream << "test_AllToAllvTimeDoubleDEC" << myrank << " target " << target << " timeLoc[target] "
                     << timeLoc[target] << " recvbuf[" << index << "] " << (int ) recvbuf[index]
                     << " # " << (int ) (target*1000000 +
-                       myrank*10000 + (timeLoc[target]/deltatime[target])*100 + j)
+                       myrank*10000 + (timeLoc[target]/deltatime[target])*100 + jj)
                     << endl ;
              }
              else if ( badrecvbuf ) {
                debugStream << "test_AllToAllvTimeDoubleDEC" << myrank << " recvbuf[" << index << "] "
                     << recvbuf[index] << " ~= " << (int ) (target*1000000 +
-                       myrank*10000 + (timeLoc[target]/deltatime[target])*100 + j) << endl ;
+                       myrank*10000 + (timeLoc[target]/deltatime[target])*100 + jj) << endl ;
              }
            }
            else if ( recvbuf[index] != -1 ) {
index 99ba5c5cac38a1fbf686e43496c06641f3711fd3..ccd7146f5ebad8f0538e5277adb52a386565a41e 100644 (file)
@@ -124,7 +124,7 @@ void MPIAccessTest::test_MPI_Access_Cancel() {
                  sts = mpi_access.IRecv(&recvbuf,outcount,MPI_INT,source,
                                         RequestId[i] ) ;
                  if ( datatype == MPI_INT ) {
-                   int source, tag, error, outcount ;
+                   int error;
                    mpi_access.wait( RequestId[i] ) ;
                    mpi_access.status( RequestId[i], source, tag, error, outcount,
                                       true ) ;
index 295ac868da2ea0220464bb66aff2dd31eb3018ba..a58d7656371f1c25037d7b04b6ec5a1ab06678ac 100644 (file)
@@ -109,7 +109,7 @@ void MPIAccessTest::test_MPI_Access_ISendRecv() {
                << ")" << endl ;
           mpi_access.test( SendRequestId[j], flag ) ;
           if ( flag ) {
-            int target, tag, error, outcount ;
+            int tag, error, outcount ;
               mpi_access.status( SendRequestId[j], target, tag, error, outcount,
                                  true ) ;
               debugStream << "test" << myrank << " Send RequestId " << SendRequestId[j]
index 7c92eb3479568c329d4b0dfb4919d9187db7e3b4..99aaf640b626acaf81cb71aecf3181a953158266 100644 (file)
@@ -102,7 +102,7 @@ void MPIAccessTest::test_MPI_Access_ISend_IRecv() {
         mpi_access.test( RecvRequestId[j], flag ) ;
       }
       if ( flag ) {
-        int target,source, tag, error, outcount ;
+        int source, tag, error, outcount ;
         if ( myrank == 0 ) {
           mpi_access.status( SendRequestId[j], target, tag, error, outcount,
                              true ) ;
@@ -169,7 +169,6 @@ void MPIAccessTest::test_MPI_Access_ISend_IRecv() {
   if ( myrank == 0 ) {
     int sendrequests[maxreq] ;
     int sendreqsize = mpi_access.sendRequestIds( target , maxreq , sendrequests ) ;
-    int i ;
     if ( sendreqsize != 0 ) {
       ostringstream strstream ;
       strstream << "=========================================================" << endl
index 208f7b55d0823debd88aa1991328e0b39dda7ffc..5a5263ac313ded73b1a5cc256fbbedcd726baad3 100644 (file)
@@ -141,28 +141,26 @@ void MPIAccessTest::test_MPI_Access_ISend_IRecv_BottleNeck() {
 
   if(MPI_ACCESS_VERBOSE) mpi_access.check() ;
   if ( myrank == 0 ) {
-    int size = mpi_access.sendRequestIdsSize() ;
-    debugStream << "test" << myrank << " before WaitAll sendreqsize " << size << endl ;
+    int size2 = mpi_access.sendRequestIdsSize() ;
+    debugStream << "test" << myrank << " before WaitAll sendreqsize " << size2 << endl ;
     mpi_access.waitAll(maxreq, SendRequestId) ;
-    size = mpi_access.sendRequestIdsSize() ;
-    debugStream << "test" << myrank << " after WaitAll sendreqsize " << size << endl ;
-    int * ArrayOfSendRequests = new int[ size ] ;
-    int nSendRequest = mpi_access.sendRequestIds( size , ArrayOfSendRequests ) ;
-    int i ;
+    size2 = mpi_access.sendRequestIdsSize() ;
+    debugStream << "test" << myrank << " after WaitAll sendreqsize " << size2 << endl ;
+    int * ArrayOfSendRequests = new int[ size2 ] ;
+    int nSendRequest = mpi_access.sendRequestIds( size2 , ArrayOfSendRequests ) ;
     for ( i = 0 ; i < nSendRequest ; i++ ) {
        mpi_access.deleteRequest( ArrayOfSendRequests[i] ) ;
     }
     delete [] ArrayOfSendRequests ;
   }
   else {
-    int size = mpi_access.recvRequestIdsSize() ;
-    debugStream << "test" << myrank << " before WaitAll recvreqsize " << size << endl ;
+    int size2 = mpi_access.recvRequestIdsSize() ;
+    debugStream << "test" << myrank << " before WaitAll recvreqsize " << size2 << endl ;
     mpi_access.waitAll(maxreq, RecvRequestId) ;
-    size = mpi_access.recvRequestIdsSize() ;
-    debugStream << "test" << myrank << " after WaitAll recvreqsize " << size << endl ;
-    int * ArrayOfRecvRequests = new int[ size ] ;
-    int nRecvRequest = mpi_access.recvRequestIds( size , ArrayOfRecvRequests ) ;
-    int i ;
+    size2 = mpi_access.recvRequestIdsSize() ;
+    debugStream << "test" << myrank << " after WaitAll recvreqsize " << size2 << endl ;
+    int * ArrayOfRecvRequests = new int[ size2 ] ;
+    int nRecvRequest = mpi_access.recvRequestIds( size2 , ArrayOfRecvRequests ) ;
     for ( i = 0 ; i < nRecvRequest ; i++ ) {
        mpi_access.deleteRequest( ArrayOfRecvRequests[i] ) ;
     }
@@ -173,7 +171,6 @@ void MPIAccessTest::test_MPI_Access_ISend_IRecv_BottleNeck() {
   if ( myrank == 0 ) {
     int sendrequests[maxreq] ;
     int sendreqsize = mpi_access.sendRequestIds( target , maxreq , sendrequests ) ;
-    int i ;
     if ( sendreqsize != 0 ) {
       ostringstream strstream ;
       strstream << "=========================================================" << endl
index eb76b358d65d8af83aaf8c7b36c0882779994f63..5ba6afe14d2b3661e8c59c7e7f7f5044c9ae4bda 100644 (file)
@@ -107,12 +107,12 @@ void MPIAccessTest::test_MPI_Access_ISend_IRecv_Length() {
         mpi_access.test( RecvRequestId[j], flag ) ;
       }
       if ( flag ) {
-        int target,source, tag, error, outcount ;
+        int target2,source, tag, error, outcount ;
         if ( myrank == 0 ) {
-          mpi_access.status( SendRequestId[j], target, tag, error, outcount,
+          mpi_access.status( SendRequestId[j], target2, tag, error, outcount,
                              true ) ;
           debugStream << "test" << myrank << " Test(Send RequestId " << SendRequestId[j]
-               << ") : target " << target << " tag " << tag << " error " << error
+               << ") : target " << target2 << " tag " << tag << " error " << error
                << " flag " << flag << endl ;
         }
         else {
index 674d47e82024af51307503c54e846b57d2edad25..93a34cb51ad749292aec9b194f06e79dbb7ebaf3 100644 (file)
@@ -94,7 +94,7 @@ void MPIAccessTest::test_MPI_Access_ISend_IRecv_Length_1() {
     }
     int j ;
     for (j = 1 ; j <= i ; j++) {
-      int source ;
+      int source = 0;
       MPI_Datatype datatype = 0;
       int outcount = 0;
       int flag ;
@@ -125,7 +125,7 @@ void MPIAccessTest::test_MPI_Access_ISend_IRecv_Length_1() {
       }
       if ( flag ) {
         if ( myrank == 0 ) {
-          int target, tag, error, outcount ;
+          int tag, error ;
           mpi_access.status( SendRequestId[j], target, tag, error, outcount,
                              true ) ;
           debugStream << "test" << myrank << " Test(Send RequestId " << SendRequestId[j]
@@ -175,10 +175,8 @@ void MPIAccessTest::test_MPI_Access_ISend_IRecv_Length_1() {
     debugStream << "test" << myrank << " TestAll SendRequest flag " << flag << endl ;
   }
   else {
-    int i ;
     int source ;
     int outcount ;
-    int flag ;
     if ( maxirecv != maxreq ) {
       ostringstream strstream ;
       strstream << "==========================================================="
index 684e8d0573fdb85402a5b7e5a5e7be8e6d5d5936..a5067ea257f31248e51971cfed6f61c2459ed037 100644 (file)
@@ -129,7 +129,7 @@ void MPIAccessTest::test_MPI_Access_Time() {
         mpi_access.test( RecvTimeRequestId[j], flag ) ;
       }
       if ( flag ) {
-        int target,source, tag, error, outcount ;
+        int source, tag, error, outcount ;
         if ( myrank == 0 ) {
           mpi_access.status( SendTimeRequestId[j], target, tag, error, outcount,
                              true ) ;
@@ -170,7 +170,7 @@ void MPIAccessTest::test_MPI_Access_Time() {
         mpi_access.test( RecvRequestId[j], flag ) ;
       }
       if ( flag ) {
-        int target,source, tag, error, outcount ;
+        int source, tag, error, outcount ;
         if ( myrank == 0 ) {
           mpi_access.status( SendRequestId[j], target, tag, error, outcount,
                              true ) ;
index d6e385ec7582ae941c28831bdc7aa416b587c7ad..8d78360baa1832d3528ffadfcd841be94b999a60 100644 (file)
@@ -37,8 +37,6 @@ void BOOSTRenumbering::renumber(const mcIdType *graph, const mcIdType *index_gra
   typedef boost::adjacency_list<boost::vecS, boost::vecS, boost::undirectedS, 
      boost::property<boost::vertex_color_t, boost::default_color_type,
        boost::property<boost::vertex_degree_t,mcIdType> > > Graph;
-  typedef boost::graph_traits<Graph>::vertex_descriptor Vertex;
-  typedef boost::graph_traits<Graph>::vertices_size_type size_type;
   Graph G(nbCell);
   for (mcIdType i=0;i<nbCell;++i)
     for (mcIdType j=index_graph[i];j<index_graph[i+1];++j)