From 50bc8f9624c44d0c5895342040bc6e626e597a8f Mon Sep 17 00:00:00 2001 From: aml Date: Tue, 28 Jul 2015 12:18:04 +0300 Subject: [PATCH] 0026395: Merge clasees NCollection_CellFilter_NDim and NCollection_CellFilter Deleted exceed class CellFilterNDim. Now dimension count used as input parameter in NCollection_CellFilter. minor corrections. --- .../BRepBuilderAPI_FastSewing.cxx | 2 +- src/BRepBuilderAPI/BRepBuilderAPI_Sewing.cxx | 2 +- src/BRepMesh/BRepMesh_CircleTool.cxx | 4 +- src/BRepMesh/BRepMesh_CircleTool.hxx | 4 +- src/BRepMesh/BRepMesh_VertexTool.cxx | 2 +- src/BRepMesh/BRepMesh_VertexTool.hxx | 4 +- src/Extrema/Extrema_GenExtCC.gxx | 2 +- src/NCollection/FILES | 1 - src/NCollection/NCollection_CellFilter.hxx | 91 ++-- .../NCollection_CellFilterNDim.hxx | 404 ------------------ src/NCollection/NCollection_LocalArray.hxx | 15 +- src/RWStl/RWStl.cxx | 4 +- src/math/math_GlobOptMin.cxx | 2 +- src/math/math_GlobOptMin.hxx | 10 +- 14 files changed, 79 insertions(+), 468 deletions(-) delete mode 100644 src/NCollection/NCollection_CellFilterNDim.hxx diff --git a/src/BRepBuilderAPI/BRepBuilderAPI_FastSewing.cxx b/src/BRepBuilderAPI/BRepBuilderAPI_FastSewing.cxx index 900481b5f9..0b46d115e3 100644 --- a/src/BRepBuilderAPI/BRepBuilderAPI_FastSewing.cxx +++ b/src/BRepBuilderAPI/BRepBuilderAPI_FastSewing.cxx @@ -284,7 +284,7 @@ void BRepBuilderAPI_FastSewing::Perform(void) Standard_Real aRange = Compute3DRange(); Handle(NCollection_IncAllocator) anAlloc = new NCollection_IncAllocator; NCollection_CellFilter - aCells(Max(myTolerance, aRange/IntegerLast()), anAlloc); + aCells(NodeInspector::Dimension, Max(myTolerance, aRange/IntegerLast()), anAlloc); for(Standard_Integer i = myFaceVec.Lower(); i <= myFaceVec.Upper(); i++) { diff --git a/src/BRepBuilderAPI/BRepBuilderAPI_Sewing.cxx b/src/BRepBuilderAPI/BRepBuilderAPI_Sewing.cxx index 4a8407c712..1bd77e5693 100644 --- a/src/BRepBuilderAPI/BRepBuilderAPI_Sewing.cxx +++ b/src/BRepBuilderAPI/BRepBuilderAPI_Sewing.cxx @@ -2778,7 +2778,7 @@ static Standard_Boolean GlueVertices(TopTools_IndexedDataMapOfShapeShape& aVerte Standard_Integer i, nbVertices = aVertexNode.Extent(); // Create map of node -> vertices TopTools_IndexedDataMapOfShapeListOfShape NodeVertices; - BRepBuilderAPI_CellFilter aFilter (Tolerance); + BRepBuilderAPI_CellFilter aFilter (BRepBuilderAPI_VertexInspector::Dimension, Tolerance); BRepBuilderAPI_VertexInspector anInspector (Tolerance); for (i = 1; i <= nbVertices; i++) { TopoDS_Shape vertex = aVertexNode.FindKey(i); diff --git a/src/BRepMesh/BRepMesh_CircleTool.cxx b/src/BRepMesh/BRepMesh_CircleTool.cxx index 5697216273..1437adfb64 100644 --- a/src/BRepMesh/BRepMesh_CircleTool.cxx +++ b/src/BRepMesh/BRepMesh_CircleTool.cxx @@ -50,7 +50,7 @@ BRepMesh_CircleTool::BRepMesh_CircleTool( const Handle(NCollection_IncAllocator)& theAllocator) : myTolerance (Precision::PConfusion() * Precision::PConfusion()), myAllocator (theAllocator), - myCellFilter(10, theAllocator), + myCellFilter(BRepMesh_CircleInspector::Dimension, 10, theAllocator), mySelector (myTolerance, 64, theAllocator) { } @@ -64,7 +64,7 @@ BRepMesh_CircleTool::BRepMesh_CircleTool( const Handle(NCollection_IncAllocator)& theAllocator) : myTolerance (Precision::PConfusion() * Precision::PConfusion()), myAllocator (theAllocator), - myCellFilter(10, theAllocator), + myCellFilter(BRepMesh_CircleInspector::Dimension, 10, theAllocator), mySelector (myTolerance, Max(theReservedSize, 64), theAllocator) { } diff --git a/src/BRepMesh/BRepMesh_CircleTool.hxx b/src/BRepMesh/BRepMesh_CircleTool.hxx index c74a2a4fe6..a81e739b63 100644 --- a/src/BRepMesh/BRepMesh_CircleTool.hxx +++ b/src/BRepMesh/BRepMesh_CircleTool.hxx @@ -25,6 +25,7 @@ #include #include #include +#include class gp_Circ2d; @@ -67,7 +68,8 @@ public: inline void SetCellSize(const Standard_Real theSizeX, const Standard_Real theSizeY) { - Standard_Real aCellSize[2] = { theSizeX, theSizeY }; + Standard_Real aCellSizeC[2] = { theSizeX, theSizeY }; + NCollection_Array1 aCellSize(aCellSizeC[0], 1, 2); myCellFilter.Reset(aCellSize, myAllocator); } diff --git a/src/BRepMesh/BRepMesh_VertexTool.cxx b/src/BRepMesh/BRepMesh_VertexTool.cxx index dfdff4bd09..519ec2599c 100644 --- a/src/BRepMesh/BRepMesh_VertexTool.cxx +++ b/src/BRepMesh/BRepMesh_VertexTool.cxx @@ -59,7 +59,7 @@ BRepMesh_VertexTool::BRepMesh_VertexTool( const Standard_Integer theReservedSize, const Handle(NCollection_IncAllocator)& theAllocator) : myAllocator (theAllocator), - myCellFilter(0., myAllocator), + myCellFilter(BRepMesh_VertexInspector::Dimension, 0., myAllocator), mySelector (Max(theReservedSize, 64),myAllocator) { const Standard_Real aTol = Precision::Confusion(); diff --git a/src/BRepMesh/BRepMesh_VertexTool.hxx b/src/BRepMesh/BRepMesh_VertexTool.hxx index dbccc2d4fc..4648331deb 100644 --- a/src/BRepMesh/BRepMesh_VertexTool.hxx +++ b/src/BRepMesh/BRepMesh_VertexTool.hxx @@ -14,6 +14,7 @@ #ifndef _BRepMesh_VertexTool_HeaderFile #define _BRepMesh_VertexTool_HeaderFile +#include #include #include #include @@ -54,7 +55,8 @@ public: Standard_EXPORT void SetCellSize(const Standard_Real theSizeX, const Standard_Real theSizeY) { - Standard_Real aCellSize[2] = { theSizeX, theSizeY }; + Standard_Real aCellSizeC[2] = { theSizeX, theSizeY }; + NCollection_Array1 aCellSize(aCellSizeC[0], 1, 2); myCellFilter.Reset(aCellSize, myAllocator); mySelector.Clear(); } diff --git a/src/Extrema/Extrema_GenExtCC.gxx b/src/Extrema/Extrema_GenExtCC.gxx index 6acba89bd9..421d507535 100644 --- a/src/Extrema/Extrema_GenExtCC.gxx +++ b/src/Extrema/Extrema_GenExtCC.gxx @@ -210,7 +210,7 @@ void Extrema_GenExtCC::Perform() anIntervals2.Upper() - anIntervals2.Lower()) * Precision::PConfusion() / (2.0 * Sqrt(2.0)); Extrema_CCPointsInspector anInspector(Precision::PConfusion()); - NCollection_CellFilter aFilter(aCellSize); + NCollection_CellFilter aFilter(Extrema_CCPointsInspector::Dimension, aCellSize); NCollection_Vector aPnts; Standard_Integer i,j,k; diff --git a/src/NCollection/FILES b/src/NCollection/FILES index 324c90ddb2..07f9554296 100755 --- a/src/NCollection/FILES +++ b/src/NCollection/FILES @@ -16,7 +16,6 @@ NCollection_BaseVector.cxx NCollection_BaseVector.hxx NCollection_Buffer.hxx NCollection_CellFilter.hxx -NCollection_CellFilterNDim.hxx NCollection_Comparator.hxx NCollection_DataMap.hxx NCollection_DefaultHasher.hxx diff --git a/src/NCollection/NCollection_CellFilter.hxx b/src/NCollection/NCollection_CellFilter.hxx index 2d49f117b6..1011641093 100644 --- a/src/NCollection/NCollection_CellFilter.hxx +++ b/src/NCollection/NCollection_CellFilter.hxx @@ -17,6 +17,8 @@ #define NCollection_CellFilter_HeaderFile #include +#include +#include #include #include #include @@ -110,37 +112,29 @@ enum NCollection_CellFilter_Action * Note that method Inspect() can be const and/or virtual. */ -template -class NCollection_CellFilter -{ +template class NCollection_CellFilter +{ public: typedef TYPENAME Inspector::Target Target; typedef TYPENAME Inspector::Point Point; public: - //! Constructor; initialized by cell size. + //! Constructor; initialized by dimension count and cell size. //! - //! Note: the cell size must be ensured to be greater than + //! Note: the cell size must be ensured to be greater than //! maximal co-ordinate of the involved points divided by INT_MAX, //! in order to avoid integer overflow of cell index. //! //! By default cell size is 0, which is invalid; thus if default //! constructor is used, the tool must be initialized later with //! appropriate cell size by call to Reset() - NCollection_CellFilter (Standard_Real theCellSize=0, - const Handle(NCollection_IncAllocator)& theAlloc=0) - { - Reset (theCellSize, theAlloc); - } - - //! Constructor; initialized by cell sizes along each dimension. - //! Note: the cell size in each dimension must be ensured to be greater than - //! maximal co-ordinate of the involved points by this dimension divided by INT_MAX, - //! in order to avoid integer overflow of cell index. - NCollection_CellFilter (Standard_Real theCellSize[], - const Handle(NCollection_IncAllocator)& theAlloc=0) + NCollection_CellFilter (const Standard_Integer theDim, + const Standard_Real theCellSize = 0, + const Handle(NCollection_IncAllocator)& theAlloc = 0) + : myCellSize(0, theDim - 1) { + myDim = theDim; Reset (theCellSize, theAlloc); } @@ -148,17 +142,16 @@ public: void Reset (Standard_Real theCellSize, const Handle(NCollection_IncAllocator)& theAlloc=0) { - for (int i=0; i < Inspector::Dimension; i++) - myCellSize[i] = theCellSize; + for (int i=0; i < myDim; i++) + myCellSize(i) = theCellSize; resetAllocator ( theAlloc ); } //! Clear the data structures and set new cell sizes and allocator - void Reset (Standard_Real theCellSize[], + void Reset (NCollection_Array1 theCellSize, const Handle(NCollection_IncAllocator)& theAlloc=0) { - for (int i=0; i < Inspector::Dimension; i++) - myCellSize[i] = theCellSize[i]; + myCellSize = theCellSize; resetAllocator ( theAlloc ); } @@ -180,7 +173,7 @@ public: Cell aCellMax (thePntMax, myCellSize); Cell aCell = aCellMin; // add object recursively into all cells in range - iterateAdd (Inspector::Dimension-1, aCell, aCellMin, aCellMax, theTarget); + iterateAdd (myDim-1, aCell, aCellMin, aCellMax, theTarget); } //! Find a target object at a point and remove it from the structures. @@ -204,7 +197,7 @@ public: Cell aCellMax (thePntMax, myCellSize); Cell aCell = aCellMin; // remove object recursively from all cells in range - iterateRemove (Inspector::Dimension-1, aCell, aCellMin, aCellMax, theTarget); + iterateRemove (myDim-1, aCell, aCellMin, aCellMax, theTarget); } //! Inspect all targets in the cell corresponding to the given point @@ -225,7 +218,7 @@ public: Cell aCellMax (thePntMax, myCellSize); Cell aCell = aCellMin; // inspect object recursively into all cells in range - iterateInspect (Inspector::Dimension-1, aCell, + iterateInspect (myDim-1, aCell, aCellMin, aCellMax, theInspector); } @@ -238,7 +231,14 @@ protected: /** * Auxiliary class for storing points belonging to the cell as the list */ - struct ListNode { + struct ListNode + { + ListNode() + { + // Empty constructor is forbidden. + Standard_NoSuchObject::Raise("NCollection_CellFilter::ListNode()"); + } + Target Object; ListNode *Next; }; @@ -251,17 +251,16 @@ protected: struct Cell { public: - //! Empty constructor -- required only for NCollection_Map, - //! therefore does not initialize index (avoid cycle) - Cell () : Objects(0) {} //! Constructor; computes cell indices - Cell (const Point& thePnt, const Standard_Real theCellSize[]) - : Objects(0) + Cell (const Point& thePnt, + const NCollection_Array1& theCellSize) + : index(theCellSize.Size()), + Objects(0) { - for (int i=0; i < Inspector::Dimension; i++) + for (int i = 0; i < theCellSize.Size(); i++) { - Standard_Real val = (Standard_Real)(Inspector::Coord(i, thePnt) / theCellSize[i]); + Standard_Real val = (Standard_Real)(Inspector::Coord(i, thePnt) / theCellSize(theCellSize.Lower() + i)); //If the value of index is greater than //INT_MAX it is decreased correspondingly for the value of INT_MAX. If the value //of index is less than INT_MIN it is increased correspondingly for the absolute @@ -273,13 +272,19 @@ protected: } //! Copy constructor: ensure that list is not deleted twice - Cell (const Cell& theOther) { (*this) = theOther; } + Cell (const Cell& theOther) + : index(theOther.index.Size()) + { + (*this) = theOther; + } //! Assignment operator: ensure that list is not deleted twice void operator = (const Cell& theOther) { - for (int i=0; i < Inspector::Dimension; i++) - index[i] = theOther.index[i]; + Standard_Integer myDim = Standard_Integer(theOther.index.Size()); + for(Standard_Integer anIdx = 0; anIdx < myDim; anIdx++) + index[anIdx] = theOther.index[anIdx]; + Objects = theOther.Objects; ((Cell&)theOther).Objects = 0; } @@ -296,7 +301,8 @@ protected: //! Compare cell with other one Standard_Boolean IsEqual (const Cell& theOther) const { - for (int i=0; i < Inspector::Dimension; i++) + Standard_Integer myDim = Standard_Integer(theOther.index.Size()); + for (int i=0; i < myDim; i++) if ( index[i] != theOther.index[i] ) return Standard_False; return Standard_True; } @@ -305,15 +311,16 @@ protected: Standard_Integer HashCode (const Standard_Integer theUpper) const { // number of bits per each dimension in the hash code - const Standard_Size aShiftBits = (BITS(long)-1) / Inspector::Dimension; + Standard_Integer myDim = Standard_Integer(index.Size()); + const Standard_Size aShiftBits = (BITS(long)-1) / myDim; long aCode=0; - for (int i=0; i < Inspector::Dimension; i++) + for (int i=0; i < myDim; i++) aCode = ( aCode << aShiftBits ) ^ index[i]; return (unsigned)aCode % theUpper; } public: - long index[Inspector::Dimension]; + NCollection_LocalArray index; ListNode *Objects; }; @@ -452,9 +459,10 @@ protected: } protected: + Standard_Integer myDim; Handle(NCollection_BaseAllocator) myAllocator; NCollection_Map myCells; - Standard_Real myCellSize [Inspector::Dimension]; + NCollection_Array1 myCellSize; }; /** @@ -504,4 +512,3 @@ struct NCollection_CellFilter_InspectorXY }; #endif - diff --git a/src/NCollection/NCollection_CellFilterNDim.hxx b/src/NCollection/NCollection_CellFilterNDim.hxx deleted file mode 100644 index d61a2d59df..0000000000 --- a/src/NCollection/NCollection_CellFilterNDim.hxx +++ /dev/null @@ -1,404 +0,0 @@ -// Created on: 2015-06-17 -// Created by: Alexander Malyshev -// Copyright (c) 2007-2015 OPEN CASCADE SAS -// -// This file is part of Open CASCADE Technology software library. -// -// This library is free software; you can redistribute it and/or modify it under -// the terms of the GNU Lesser General Public License version 2.1 as published -// by the Free Software Foundation, with special exception defined in the file -// OCCT_LGPL_EXCEPTION.txt. Consult the file LICENSE_LGPL_21.txt included in OCCT -// distribution for complete text of the license and disclaimer of any warranty. -// -// Alternatively, this file may be used under the terms of Open CASCADE -// commercial license or contractual agreement. - -#ifndef NCollection_CellFilterNDim_HeaderFile -#define NCollection_CellFilterNDim_HeaderFile - -#include -#include -#include -#include -#include -#include -#include -#include - -/** - * A data structure for sorting geometric objects (called targets) in - * n-dimensional space into cells, with associated algorithm for fast checking - * of coincidence (overlapping, intersection, etc.) with other objects - * (called here bullets). - * - * Purpose of this class is to add possibility to work with CellFilter with unknown - dimension count at compilation time. - * - * For more details look at base class NCollection_CellFilter. - * - */ - -template class NCollection_CellFilterNDim -{ -public: - typedef TYPENAME Inspector::Target Target; - typedef TYPENAME Inspector::Point Point; - -public: - - //! Constructor; initialized by dimension count and cell size. - //! - //! Note: the cell size must be ensured to be greater than - //! maximal co-ordinate of the involved points divided by INT_MAX, - //! in order to avoid integer overflow of cell index. - //! - //! By default cell size is 0, which is invalid; thus if default - //! constructor is used, the tool must be initialized later with - //! appropriate cell size by call to Reset() - NCollection_CellFilterNDim (const Standard_Integer theDim, - const Standard_Real theCellSize = 0, - const Handle(NCollection_IncAllocator)& theAlloc = 0) - : myCellSize(0, theDim - 1) - { - myDim = theDim; - Reset (theCellSize, theAlloc); - } - - //! Constructor; initialized by dimension count and cell sizes along each dimension. - //! Note: the cell size in each dimension must be ensured to be greater than - //! maximal co-ordinate of the involved points by this dimension divided by INT_MAX, - //! in order to avoid integer overflow of cell index. - NCollection_CellFilterNDim (const Standard_Integer theDim, - const NCollection_Array1 theCellSize, - const Handle(NCollection_IncAllocator)& theAlloc = 0) - : myCellSize(0, theDim - 1) - { - myDim = theDim; - Reset (theCellSize, theAlloc); - } - - //! Clear the data structures, set new cell size and allocator - void Reset (Standard_Real theCellSize, - const Handle(NCollection_IncAllocator)& theAlloc=0) - { - for (int i=0; i < myDim; i++) - myCellSize(i) = theCellSize; - resetAllocator ( theAlloc ); - } - - //! Clear the data structures and set new cell sizes and allocator - void Reset (NCollection_Array1 theCellSize, - const Handle(NCollection_IncAllocator)& theAlloc=0) - { - myCellSize = theCellSize; - resetAllocator ( theAlloc ); - } - - //! Adds a target object for further search at a point (into only one cell) - void Add (const Target& theTarget, const Point &thePnt) - { - Cell aCell (thePnt, myCellSize); - add (aCell, theTarget); - } - - //! Adds a target object for further search in the range of cells - //! defined by two points (the first point must have all co-ordinates equal or - //! less than the same co-ordinate of the second point) - void Add (const Target& theTarget, - const Point &thePntMin, const Point &thePntMax) - { - // get cells range by minimal and maximal co-ordinates - Cell aCellMin (thePntMin, myCellSize); - Cell aCellMax (thePntMax, myCellSize); - Cell aCell = aCellMin; - // add object recursively into all cells in range - iterateAdd (myDim-1, aCell, aCellMin, aCellMax, theTarget); - } - - //! Find a target object at a point and remove it from the structures. - //! For usage of this method "operator ==" should be defined for Target. - void Remove (const Target& theTarget, const Point &thePnt) - { - Cell aCell (thePnt, myCellSize); - remove (aCell, theTarget); - } - - //! Find a target object in the range of cells defined by two points and - //! remove it from the structures - //! (the first point must have all co-ordinates equal or - //! less than the same co-ordinate of the second point). - //! For usage of this method "operator ==" should be defined for Target. - void Remove (const Target& theTarget, - const Point &thePntMin, const Point &thePntMax) - { - // get cells range by minimal and maximal co-ordinates - Cell aCellMin (thePntMin, myCellSize); - Cell aCellMax (thePntMax, myCellSize); - Cell aCell = aCellMin; - // remove object recursively from all cells in range - iterateRemove (myDim-1, aCell, aCellMin, aCellMax, theTarget); - } - - //! Inspect all targets in the cell corresponding to the given point - void Inspect (const Point& thePnt, Inspector &theInspector) - { - Cell aCell (thePnt, myCellSize); - inspect (aCell, theInspector); - } - - //! Inspect all targets in the cells range limited by two given points - //! (the first point must have all co-ordinates equal or - //! less than the same co-ordinate of the second point) - void Inspect (const Point& thePntMin, const Point& thePntMax, - Inspector &theInspector) - { - // get cells range by minimal and maximal co-ordinates - Cell aCellMin (thePntMin, myCellSize); - Cell aCellMax (thePntMax, myCellSize); - Cell aCell = aCellMin; - // inspect object recursively into all cells in range - iterateInspect (myDim-1, aCell, - aCellMin, aCellMax, theInspector); - } - -#if defined(__SUNPRO_CC) && (__SUNPRO_CC <= 0x530) -public: // work-around against obsolete SUN WorkShop 5.3 compiler -#else -protected: -#endif - - /** - * Auxiliary class for storing points belonging to the cell as the list - */ - struct ListNode - { - ListNode() - { - // Empty constructor is forbidden. - Standard_NoSuchObject::Raise("NCollection_CellFilterNDim::ListNode()"); - } - - Target Object; - ListNode *Next; - }; - - /** - * Auxilary structure representing a cell in the space. - * Cells are stored in the map, each cell contains list of objects - * that belong to that cell. - */ - struct Cell - { - public: - - //! Constructor; computes cell indices - Cell (const Point& thePnt, - const NCollection_Array1 theCellSize) - : index(0, theCellSize.Size() - 1), - Objects(0) - { - for (int i=0; i < theCellSize.Size(); i++) - { - Standard_Real val = (Standard_Real)(Inspector::Coord(i, thePnt) / theCellSize(i)); - //If the value of index is greater than - //INT_MAX it is decreased correspondingly for the value of INT_MAX. If the value - //of index is less than INT_MIN it is increased correspondingly for the absolute - //value of INT_MIN. - index(i) = long((val > INT_MAX - 1) ? fmod(val, (Standard_Real) INT_MAX) - : (val < INT_MIN + 1) ? fmod(val, (Standard_Real) INT_MIN) - : val); - } - } - - //! Copy constructor: ensure that list is not deleted twice - Cell (const Cell& theOther) - : index(0, theOther.index.Size() - 1) - { - (*this) = theOther; - } - - //! Assignment operator: ensure that list is not deleted twice - void operator = (const Cell& theOther) - { - index = theOther.index; - Objects = theOther.Objects; - ((Cell&)theOther).Objects = 0; - } - - //! Destructor; calls destructors for targets contained in the list - ~Cell () - { - for ( ListNode* aNode = Objects; aNode; aNode = aNode->Next ) - aNode->Object.~Target(); - // note that list nodes need not to be freed, since IncAllocator is used - Objects = 0; - } - - //! Compare cell with other one - Standard_Boolean IsEqual (const Cell& theOther) const - { - Standard_Integer myDim = theOther.index.Size(); - for (int i=0; i < myDim; i++) - if ( index(i) != theOther.index(i) ) return Standard_False; - return Standard_True; - } - - //! Compute hash code - Standard_Integer HashCode (const Standard_Integer theUpper) const - { - // number of bits per each dimension in the hash code - Standard_Integer myDim = index.Size(); - const Standard_Size aShiftBits = (BITS(long)-1) / myDim; - long aCode=0; - for (int i=0; i < myDim; i++) - aCode = ( aCode << aShiftBits ) ^ index(i); - return (unsigned)aCode % theUpper; - } - - public: - NCollection_Array1 index; - ListNode *Objects; - }; - - // definition of global functions is needed for map - friend Standard_Integer HashCode (const Cell &aCell, const Standard_Integer theUpper) - { return aCell.HashCode(theUpper); } - friend Standard_Boolean IsEqual (const Cell &aCell1, const Cell &aCell2) - { return aCell1.IsEqual(aCell2); } - -protected: - - //! Reset allocator to the new one - void resetAllocator (const Handle(NCollection_IncAllocator)& theAlloc) - { - if ( theAlloc.IsNull() ) - myAllocator = new NCollection_IncAllocator; - else - myAllocator = theAlloc; - myCells.Clear ( myAllocator ); - } - - //! Add a new target object into the specified cell - void add (const Cell& theCell, const Target& theTarget) - { - // add a new cell or get reference to existing one - Cell& aMapCell = (Cell&)myCells.Added (theCell); - - // create a new list node and add it to the beginning of the list - ListNode* aNode = (ListNode*)myAllocator->Allocate(sizeof(ListNode)); - new (&aNode->Object) Target (theTarget); - aNode->Next = aMapCell.Objects; - aMapCell.Objects = aNode; - } - - //! Internal addition function, performing iteration for adjacent cells - //! by one dimension; called recursively to cover all dimensions - void iterateAdd (int idim, Cell &theCell, - const Cell& theCellMin, const Cell& theCellMax, - const Target& theTarget) - { - int start = theCellMin.index(idim); - int end = theCellMax.index(idim); - for (int i=start; i <= end; i++) { - theCell.index(idim) = i; - if ( idim ) // recurse - iterateAdd (idim-1, theCell, theCellMin, theCellMax, theTarget); - else // add to this cell - add (theCell, theTarget); - } - } - - //! Remove the target object from the specified cell - void remove (const Cell& theCell, const Target& theTarget) - { - // check if any objects are recorded in that cell - if ( ! myCells.Contains (theCell) ) - return; - - // iterate by objects in the cell and check each - Cell& aMapCell = (Cell&)myCells.Added (theCell); - ListNode* aNode = aMapCell.Objects; - ListNode* aPrev = NULL; - while (aNode) - { - ListNode* aNext = aNode->Next; - if (Inspector::IsEqual (aNode->Object, theTarget)) - { - aNode->Object.~Target(); - (aPrev ? aPrev->Next : aMapCell.Objects) = aNext; - // note that aNode itself need not to be freed, since IncAllocator is used - } - else - aPrev = aNode; - aNode = aNext; - } - } - - //! Internal removal function, performing iteration for adjacent cells - //! by one dimension; called recursively to cover all dimensions - void iterateRemove (int idim, Cell &theCell, - const Cell& theCellMin, const Cell& theCellMax, - const Target& theTarget) - { - int start = theCellMin.index(idim); - int end = theCellMax.index(idim); - for (int i=start; i <= end; i++) { - theCell.index(idim) = i; - if ( idim ) // recurse - iterateRemove (idim-1, theCell, theCellMin, theCellMax, theTarget); - else // remove from this cell - remove (theCell, theTarget); - } - } - - //! Inspect the target objects in the specified cell. - void inspect (const Cell& theCell, Inspector& theInspector) - { - // check if any objects are recorded in that cell - if ( ! myCells.Contains (theCell) ) - return; - - // iterate by objects in the cell and check each - Cell& aMapCell = (Cell&)myCells.Added (theCell); - ListNode* aNode = aMapCell.Objects; - ListNode* aPrev = NULL; - while(aNode) { - ListNode* aNext = aNode->Next; - NCollection_CellFilter_Action anAction = - theInspector.Inspect (aNode->Object); - // delete items requested to be purged - if ( anAction == CellFilter_Purge ) { - aNode->Object.~Target(); - (aPrev ? aPrev->Next : aMapCell.Objects) = aNext; - // note that aNode itself need not to be freed, since IncAllocator is used - } - else - aPrev = aNode; - aNode = aNext; - } - } - - //! Inspect the target objects in the specified range of the cells - void iterateInspect (int idim, Cell &theCell, - const Cell& theCellMin, const Cell& theCellMax, - Inspector& theInspector) - { - int start = theCellMin.index(idim); - int end = theCellMax.index(idim); - for (int i=start; i <= end; i++) { - theCell.index(idim) = i; - if ( idim ) // recurse - iterateInspect (idim-1, theCell, theCellMin, theCellMax, theInspector); - else // inspect this cell - inspect (theCell, theInspector); - } - } - -protected: - Standard_Integer myDim; - Handle(NCollection_BaseAllocator) myAllocator; - NCollection_Map myCells; - NCollection_Array1 myCellSize; -}; - -#endif diff --git a/src/NCollection/NCollection_LocalArray.hxx b/src/NCollection/NCollection_LocalArray.hxx index ae2bbf91ca..20580cc31c 100644 --- a/src/NCollection/NCollection_LocalArray.hxx +++ b/src/NCollection/NCollection_LocalArray.hxx @@ -20,13 +20,10 @@ //! Auxiliary class optimizing creation of array buffer //! (using stack allocation for small arrays). -template class NCollection_LocalArray +template class NCollection_LocalArray { public: - // 1K * sizeof (theItem) - static const size_t MAX_ARRAY_SIZE = 1024; - NCollection_LocalArray (const size_t theSize) : myPtr (myBuffer) { @@ -34,7 +31,7 @@ public: } NCollection_LocalArray () - : myPtr (myBuffer) {} + : myPtr (myBuffer), mySize(0) {} ~NCollection_LocalArray() { @@ -48,6 +45,13 @@ public: myPtr = (theItem*)Standard::Allocate (theSize * sizeof(theItem)); else myPtr = myBuffer; + + mySize = theSize; + } + + size_t Size() const + { + return mySize; } operator theItem*() const @@ -72,6 +76,7 @@ protected: theItem myBuffer[MAX_ARRAY_SIZE]; theItem* myPtr; + size_t mySize; }; diff --git a/src/RWStl/RWStl.cxx b/src/RWStl/RWStl.cxx index 2ef056e243..042269b3bd 100644 --- a/src/RWStl/RWStl.cxx +++ b/src/RWStl/RWStl.cxx @@ -391,7 +391,7 @@ Handle(StlMesh_Mesh) RWStl::ReadBinary (const OSD_Path& thePath, ReadMesh->AddDomain (); // Filter unique vertices to share the nodes of the mesh. - BRepBuilderAPI_CellFilter uniqueVertices(Precision::Confusion()); + BRepBuilderAPI_CellFilter uniqueVertices(BRepBuilderAPI_VertexInspector::Dimension, Precision::Confusion()); BRepBuilderAPI_VertexInspector inspector(Precision::Confusion()); for (ifacet=1; ifacet<=NBFACET; ++ifacet) { @@ -480,7 +480,7 @@ Handle(StlMesh_Mesh) RWStl::ReadAscii (const OSD_Path& thePath, ReadMesh->AddDomain(); // Filter unique vertices to share the nodes of the mesh. - BRepBuilderAPI_CellFilter uniqueVertices(Precision::Confusion()); + BRepBuilderAPI_CellFilter uniqueVertices(BRepBuilderAPI_VertexInspector::Dimension, Precision::Confusion()); BRepBuilderAPI_VertexInspector inspector(Precision::Confusion()); // main reading diff --git a/src/math/math_GlobOptMin.cxx b/src/math/math_GlobOptMin.cxx index cfd712f522..57dd45f08f 100644 --- a/src/math/math_GlobOptMin.cxx +++ b/src/math/math_GlobOptMin.cxx @@ -531,7 +531,7 @@ Standard_Boolean math_GlobOptMin::isStored(const math_Vector& thePnt) } else { - NCollection_CellFilter_NDimInspector anInspector(myN, Precision::PConfusion()); + NCollection_CellFilter_Inspector anInspector(myN, Precision::PConfusion()); if (isFirstCellFilterInvoke) { myFilter.Reset(myCellSize); diff --git a/src/math/math_GlobOptMin.hxx b/src/math/math_GlobOptMin.hxx index dfb483709d..0af9820d9e 100644 --- a/src/math/math_GlobOptMin.hxx +++ b/src/math/math_GlobOptMin.hxx @@ -18,12 +18,12 @@ #include #include -#include +#include #include #include #include -class NCollection_CellFilter_NDimInspector +class NCollection_CellFilter_Inspector { public: @@ -31,8 +31,8 @@ public: typedef math_Vector Point; typedef math_Vector Target; - NCollection_CellFilter_NDimInspector(const Standard_Integer theDim, - const Standard_Real theTol) + NCollection_CellFilter_Inspector(const Standard_Integer theDim, + const Standard_Real theTol) : myCurrent(1, theDim) { myTol = theTol * theTol; @@ -201,7 +201,7 @@ private: NCollection_Array1 myCellSize; Standard_Integer myMinCellFilterSol; Standard_Boolean isFirstCellFilterInvoke; - NCollection_CellFilterNDim myFilter; + NCollection_CellFilter myFilter; Standard_Real myF; // Current value of Global optimum. };