Home
last modified time | relevance | path

Searched refs:DIM (Results 1 – 25 of 3249) sorted by relevance

12345678910>>...130

/dports/math/openmesh/OpenMesh-8.1/src/Unittests/
H A Dunittests_common_customtraits.hh36 Vec<DIM> operator+(Vec<DIM> const &lhs, Vec<DIM> const &rhs) { in operator +()
44 Vec<DIM> operator-(Vec<DIM> const &lhs, Vec<DIM> const &rhs) { in operator -()
51 template <int DIM> Vec<DIM> operator*(Vec<DIM> const &lhs, float rhs) { in operator *()
58 template <int DIM> Vec<DIM> operator*(float lhs, Vec<DIM> const &rhs) { in operator *()
69 template <int DIM> Vec<DIM> &operator+=(Vec<DIM> &lhs, Vec<DIM> const &rhs) { in operator +=()
72 template <int DIM> Vec<DIM> &operator-=(Vec<DIM> &lhs, Vec<DIM> const &rhs) { in operator -=()
75 template <int DIM> Vec<DIM> &operator*=(Vec<DIM> &lhs, float rhs) { in operator *=()
78 template <int DIM> Vec<DIM> &operator/=(Vec<DIM> &lhs, float rhs) { in operator /=()
90 template <int DIM> Vec<DIM> &vectorize(Vec<DIM> &v, float val) { in vectorize()
96 template <int DIM> Vec<DIM> &minimize(Vec<DIM> &v1, Vec<DIM> const &v2) { in minimize()
[all …]
/dports/math/igraph/igraph-0.9.5/examples/simple/
H A Digraph_sparsemat4.c63 #define EDGES (DIM*DIM/6) in main()
64 igraph_sparsemat_init(&A, DIM, DIM, EDGES + DIM); in main()
100 #define EDGES (DIM*DIM/6) in main()
101 igraph_sparsemat_init(&A, DIM, DIM, EDGES + DIM); in main()
139 #define EDGES (DIM*DIM/6) in main()
140 igraph_sparsemat_init(&A, DIM, DIM, EDGES + DIM); in main()
178 #define EDGES (DIM*DIM/6) in main()
179 igraph_sparsemat_init(&A, DIM, DIM, EDGES + DIM); in main()
222 #define EDGES (DIM*DIM/6) in main()
223 igraph_sparsemat_init(&A, DIM, DIM, EDGES + DIM); in main()
[all …]
/dports/science/libgeodecomp/libgeodecomp-0.4.0/src/geometry/partitions/
H A Dzcurvepartition.h49 Coord<DIM> origin;
274 const Coord<DIM>& origin = Coord<DIM>(),
275 const Coord<DIM>& dimensions = Coord<DIM>(),
309 Coord<DIM> maxDim = Coord<DIM>::diagonal(68 / DIM / DIM); in fillCaches()
313 CoordBox<DIM> box(Coord<DIM>(), maxDim); in fillCaches()
337 Coord<DIM> origin;
341 template<int DIM>
342 typename ZCurvePartition<DIM>::Cache ZCurvePartition<DIM>::coordsCache;
344 template<int DIM>
345 Coord<DIM> ZCurvePartition<DIM>::maxCachedDimensions;
[all …]
/dports/science/smoldyn/smoldyn-2.67/source/NextSubVolume/
H A DGeometry.h42 template <unsigned int DIM>
47 template <unsigned int DIM>
84 shortest[DIM] = coord - r[DIM]; in at_boundary()
91 shortest[DIM] = coord - r[DIM]; in shortest_vector_to_boundary()
154 : AxisAlignedPlane<DIM>(_low[DIM], _normal), in AxisAlignedRectangle()
159 high[DIM] = low[DIM]; in AxisAlignedRectangle()
169 AxisAlignedRectangle<DIM>& operator=(const AxisAlignedRectangle<DIM>& arg)
186 unirandCCD(low[dim_map[DIM][0]], high[dim_map[DIM][0]]); in get_random_point()
188 unirandCCD(low[dim_map[DIM][1]], high[dim_map[DIM][1]]); in get_random_point()
210 (high[dim_map[DIM][0]] - low[dim_map[DIM][0]]) * in get_random_point_triangle()
[all …]
H A DStructuredGrid.impl.h7 template<unsigned int DIM>
14 high_point[DIM] = low_point[DIM]; in get_intersection_of_cell()
19 template<unsigned int DIM>
26 high_point[DIM] = low_point[DIM]; in get_intersection_of_cell()
31 template<unsigned int DIM>
33 const double coord_index_double = (surface.get_coord()-low[DIM])*inv_cell_size[DIM]; in get_slice()
48 ASSERT(max_index[DIM]==min_index[DIM],"surface not an axis aligned rectangle"); in get_slice()
50 int num_indicies = (max_index[dim_map[DIM][0]] - min_index[dim_map[DIM][0]] + 1) * in get_slice()
51 (max_index[dim_map[DIM][1]] - min_index[dim_map[DIM][1]] + 1); in get_slice()
59 for (int i = min_index[dim_map[DIM][0]]; i <= max_index[dim_map[DIM][0]]; ++i) { in get_slice()
[all …]
/dports/science/py-MDAnalysis/MDAnalysis-0.19.2/MDAnalysis/lib/formats/src/
H A Dxdrfile_trr.c48 nflsize = sh->box_size / (DIM * DIM); in nFloatSize()
141 double pvd[DIM * DIM]; in do_htrn()
143 float pvf[DIM * DIM]; in do_htrn()
156 if (xdrfile_read_double(pvd, DIM * DIM, xd) == DIM * DIM) { in do_htrn()
167 if (xdrfile_read_double(pvd, DIM * DIM, xd) != DIM * DIM) in do_htrn()
172 if (xdrfile_read_double(pvd, DIM * DIM, xd) != DIM * DIM) in do_htrn()
189 if (xdrfile_read_double(dx, sh->natoms * DIM, xd) == sh->natoms * DIM) { in do_htrn()
250 if (xdrfile_read_float(pvf, DIM * DIM, xd) == DIM * DIM) { in do_htrn()
263 if (xdrfile_read_float(pvf, DIM * DIM, xd) != DIM * DIM) in do_htrn()
268 if (xdrfile_read_float(pvf, DIM * DIM, xd) != DIM * DIM) in do_htrn()
[all …]
/dports/science/axom/axom-0.6.1/src/axom/core/
H A DArray.hpp68 class Array : public ArrayBase<T, DIM, Array<T, DIM, SPACE>>
361 using ArrayBase<T, DIM, Array<T, DIM, SPACE>>::insert;
374 ArrayBase<T, DIM, Array<T, DIM, SPACE>>::insert(size(), other); in append()
599 : ArrayBase<T, DIM, Array<T, DIM, SPACE>>(args...) in Array()
639 : ArrayBase<T, DIM, Array<T, DIM, SPACE>>( in Array()
640 static_cast<const ArrayBase<T, DIM, Array<T, DIM, SPACE>>&>(other)) in Array()
663 : ArrayBase<T, DIM, Array<T, DIM, SPACE>>( in Array()
684 : ArrayBase<T, DIM, Array<T, DIM, SPACE>>(other) in Array()
910 static_cast<ArrayBase<T, DIM, Array<T, DIM, SPACE>>&>(*this) = in resize()
923 inline void Array<T, DIM, SPACE>::swap(Array<T, DIM, SPACE>& other) in swap() argument
[all …]
/dports/science/axom/axom-0.6.1/src/axom/spin/tests/
H A Dspin_morton.cpp46 template <typename CoordType, int DIM>
49 Point<CoordType, DIM> pt; in randomPoint()
50 for(int i = 0; i < DIM; ++i) in randomPoint()
134 using GridPoint = Point<CoordType, DIM>; in testMortonizer()
164 template <int DIM>
168 testMortonizer<axom::int8, axom::uint8, DIM>(); in testIntegralTypes()
193 SLIC_INFO("Testing int in " << DIM << "d -- "); in testIntegralTypes()
225 const int DIM = 2; in TEST() local
226 testIntegralTypes<DIM>(); in TEST()
235 const int DIM = 3; in TEST() local
[all …]
/dports/science/axom/axom-0.6.1/src/axom/primal/tests/
H A Dprimal_orientedboundingbox.cpp21 static const int DIM = 2; in TEST() local
37 static const int DIM = 3; in TEST() local
45 for(int i = 0; i < DIM; i++) in TEST()
87 static const int DIM = 3; in TEST() local
125 static const int DIM = 3; in TEST() local
156 static const int DIM = 3; in TEST() local
194 static const int DIM = 3; in TEST() local
244 static const int DIM = 3; in TEST() local
283 static const int DIM = 3; in TEST() local
459 QVector u_o[DIM]; in TEST()
[all …]
H A Dprimal_point.cpp18 const int DIM = 3; in check_point_policy() local
38 static const int DIM = 2; in TEST() local
51 static const int DIM = 5; in TEST() local
88 int numVals = DIM / 2; in TEST()
109 CoordType arr[DIM]; in TEST()
128 QPoint pt2(arr, DIM); in TEST()
151 int numVals = DIM / 2; in TEST()
174 CoordType arr[DIM]; in TEST()
232 CoordType arr[DIM]; in TEST()
268 CoordType arr[DIM]; in TEST()
[all …]
/dports/math/alberta/alberta3-920315ae1bbfd1b1fb6672d916619ac37a411e95/add_ons/albertasystems/Elast/Common/
H A Delast_problem.cc12 const PROB_DATA_DIFF* /*const*/ (prob_datas_elast)[DIM*DIM];
198 REAL response_block[DIM*DIM]; in init_problem_standard_steel()
207 memset(&response_block, 0, sizeof(REAL[DIM*DIM])); in init_problem_standard_steel()
210 if (DIM==3) response_block[2*DIM+2] = mu; in init_problem_standard_steel()
214 memset(&response_block, 0, sizeof(REAL[DIM*DIM])); in init_problem_standard_steel()
217 if (DIM==3) response_block[2*DIM+2] = mu; in init_problem_standard_steel()
219 if (DIM==3) in init_problem_standard_steel()
221 memset(&response_block, 0, sizeof(REAL[DIM*DIM])); in init_problem_standard_steel()
227 memset(&response_block, 0, sizeof(REAL[DIM*DIM])); in init_problem_standard_steel()
237 memset(&response_block, 0, sizeof(REAL[DIM*DIM])); in init_problem_standard_steel()
[all …]
/dports/math/moab/fathomteam-moab-7bde9dfb84a8/src/mesquite/TargetMetric/ShapeSizeOrient/
H A DAWShapeSizeOrientNB1.cpp46 template <unsigned DIM> static inline
47 bool eval( const MsqMatrix<DIM,DIM>& A, in eval() argument
48 const MsqMatrix<DIM,DIM>& W, in eval()
55 template <unsigned DIM> static inline
56 bool grad( const MsqMatrix<DIM,DIM>& A, in grad() argument
57 const MsqMatrix<DIM,DIM>& W, in grad()
59 MsqMatrix<DIM,DIM>& deriv ) in grad()
68 bool hess( const MsqMatrix<DIM,DIM>& A, in hess() argument
69 const MsqMatrix<DIM,DIM>& W, in hess()
71 MsqMatrix<DIM,DIM>& deriv, in hess()
[all …]
/dports/math/geogram/geogram-1.7.7/src/lib/geogram/basic/
H A Dmatrix.h119 template <index_t DIM, class FT>
160 return DIM; in dimension()
486 FT coeff_[DIM][DIM];
500 template <index_t DIM, class FT>
523 template <index_t DIM, class FT>
571 vecng<DIM,FT> operator*(
572 const Matrix<DIM, FT>& M, const vecng<DIM,FT>& x
574 vecng<DIM,FT> y;
593 vecng<DIM,FT> mult(
594 const Matrix<DIM, FT>& M, const vecng<DIM,FT>& x
[all …]
/dports/graphics/vigra/vigra-8acd73a/vigranumpy/src/core/
H A Dhistogram.cxx55 NumpyArray<DIM+2,float> histogram = NumpyArray<DIM+2,float>()
58 for(size_t d=0;d<DIM;++d){
61 outShape[DIM]=bins;
62 outShape[DIM+1]=CHANNELS;
73 template<unsigned int DIM>
81 NumpyArray<DIM+2,float> histogram = NumpyArray<DIM+2,float>()
87 outShape[DIM]=bins[0];
88 outShape[DIM+1]=bins[1];
101 template<unsigned int DIM>
151 template<unsigned int DIM>
[all …]
/dports/biology/seqan-apps/seqan-seqan-v2.4.0/include/seqan/map/
H A Dsumlist.h72 struct Value< SumList<DIM, TValue, TSpec> >
89 template <unsigned int DIM, typename TValue>
92 TValue values[DIM];
118 arrayCopy(arr, arr + DIM, values);
146 inline SumListValues<DIM, TValue> const &
150 for (unsigned int i = 0; i < DIM; ++i)
160 inline SumListValues<DIM, TValue> const &
164 for (unsigned int i = 0; i < DIM; ++i)
178 for (unsigned int i = 0; i < DIM; ++i)
189 for (unsigned int i = 0; i < DIM; ++i)
[all …]
/dports/biology/seqan1/seqan-1.3.1/seqan/map/
H A Dsumlist.h72 struct Value< SumList<DIM, TValue, TSpec> >
92 TValue values[DIM];
118 arrayCopy(arr, arr + DIM, values);
140 typedef SumListValues<DIM, TValue> Type;
146 inline SumListValues<DIM, TValue> const &
150 for (unsigned int i = 0; i < DIM; ++i)
160 inline SumListValues<DIM, TValue> const &
164 for (unsigned int i = 0; i < DIM; ++i)
178 for (unsigned int i = 0; i < DIM; ++i)
189 for (unsigned int i = 0; i < DIM; ++i)
[all …]
/dports/biology/seqan/seqan-library-2.4.0/include/seqan/map/
H A Dsumlist.h72 struct Value< SumList<DIM, TValue, TSpec> >
89 template <unsigned int DIM, typename TValue>
92 TValue values[DIM];
118 arrayCopy(arr, arr + DIM, values);
146 inline SumListValues<DIM, TValue> const &
150 for (unsigned int i = 0; i < DIM; ++i)
160 inline SumListValues<DIM, TValue> const &
164 for (unsigned int i = 0; i < DIM; ++i)
178 for (unsigned int i = 0; i < DIM; ++i)
189 for (unsigned int i = 0; i < DIM; ++i)
[all …]
/dports/biology/pbseqan/seqan-21d95d737d8decb5cc3693b9065d81e831e7f57d/include/seqan/map/
H A Dsumlist.h72 struct Value< SumList<DIM, TValue, TSpec> >
89 template <unsigned int DIM, typename TValue>
92 TValue values[DIM];
118 arrayCopy(arr, arr + DIM, values);
146 inline SumListValues<DIM, TValue> const &
150 for (unsigned int i = 0; i < DIM; ++i)
160 inline SumListValues<DIM, TValue> const &
164 for (unsigned int i = 0; i < DIM; ++i)
178 for (unsigned int i = 0; i < DIM; ++i)
189 for (unsigned int i = 0; i < DIM; ++i)
[all …]
/dports/science/libgeodecomp/libgeodecomp-0.4.0/src/storage/
H A Ddisplacedgrid.h24 const static int DIM = TOPOLOGY::DIM;
33 const CoordBox<DIM>& box = CoordBox<DIM>(),
36 const Coord<DIM>& topologicalDimensions = Coord<DIM>()) :
44 const Coord<DIM>& origin=Coord<DIM>()) :
54 inline Coord<DIM>& topologicalDimensions() in topologicalDimensions()
69 inline const Coord<DIM>& getOrigin() const in getOrigin()
89 inline void resize(const CoordBox<DIM>& box) in resize()
148 inline void paste(const GridBase<CELL_TYPE, DIM>& grid, const Region<DIM>& region) in paste()
162 virtual CoordBox<DIM> boundingBox() const in boundingBox()
219 Coord<DIM> origin;
[all …]
H A Dmeshlessadapter.h26 static const int DIM = TOPOLOGY::DIM; variable
40 const FloatCoord<DIM>& dimensions=FloatCoord<DIM>(),
52 inline Coord<DIM> posToCoord(const FloatCoord<DIM>& pos) const in posToCoord()
54 Coord<DIM> c; in posToCoord()
82 CoordBox<DIM> box(Coord<DIM>::diagonal(-1), Coord<DIM>::diagonal(3));
216 CoordBox<DIM> box(Coord<DIM>(), discreteDim); in reportFillLevels()
242 FloatCoord<DIM> dimensions;
243 Coord<DIM> discreteDim;
293 double distance2(const FloatCoord<DIM>& a, const FloatCoord<DIM>& b) const in distance2()
307 int manhattanDistance(const FloatCoord<DIM>& a, const FloatCoord<DIM>& b) const in manhattanDistance()
[all …]
/dports/math/moab/fathomteam-moab-7bde9dfb84a8/src/mesquite/TargetMetric/Size/
H A DAWSizeNB1.cpp46 template <unsigned DIM> static inline
47 bool eval( const MsqMatrix<DIM,DIM>& A, in eval() argument
48 const MsqMatrix<DIM,DIM>& W, in eval()
56 template <unsigned DIM> static inline
57 bool grad( const MsqMatrix<DIM,DIM>& A, in grad() argument
58 const MsqMatrix<DIM,DIM>& W, in grad()
60 MsqMatrix<DIM,DIM>& deriv ) in grad()
70 bool hess( const MsqMatrix<DIM,DIM>& A, in hess() argument
71 const MsqMatrix<DIM,DIM>& W, in hess()
73 MsqMatrix<DIM,DIM>& deriv, in hess()
[all …]
/dports/math/moab/fathomteam-moab-7bde9dfb84a8/src/mesquite/TargetMetric/ShapeOrient/
H A DTShapeOrientNB1.cpp46 template <unsigned DIM> static inline
47 bool eval( const MsqMatrix<DIM,DIM>& T, double& result ) in eval() argument
54 template <unsigned DIM> static inline
55 bool grad( const MsqMatrix<DIM,DIM>& T, in grad() argument
57 MsqMatrix<DIM,DIM>& deriv ) in grad()
64 deriv = MsqMatrix<DIM,DIM>(0.0); in grad()
73 template <unsigned DIM> static inline
74 bool hess( const MsqMatrix<DIM,DIM>& T, in hess() argument
76 MsqMatrix<DIM,DIM>& deriv, in hess()
77 MsqMatrix<DIM,DIM>* second ) in hess()
[all …]
/dports/science/libgeodecomp/libgeodecomp-0.4.0/src/geometry/
H A Dpartitionmanager.h23 static const int DIM = Topology::DIM; variable
31 const CoordBox<DIM>& simulationArea=CoordBox<DIM>())
35 new StripingPartition<DIM>(Coord<DIM>(), simulationArea.dimensions, 0, weights));
87 Region<DIM> outer = outerRim; in resetGhostZones()
212 CoordBox<DIM> simulationArea;
213 Region<DIM> outerRim;
214 Region<DIM> volatileKernel;
215 Region<DIM> innerRim;
231 Region<DIM> expanded; in fillRegion()
244 Region<DIM> surface( in fillOwnRegion()
[all …]
H A Dregion.h45 template<int DIM>
56 streak->origin[DIM] = iterators[DIM]->first; in operator()
75 template<int DIM>
166 iterators[DIM] = region.indicesBegin(DIM) + offsets[DIM]; in operator()
211 iterators[DIM] = region.indicesBegin(DIM); in operator()
245 iterators[DIM] = region.indicesEnd(DIM); in operator()
270 if (s1.origin[DIM] != s2.origin[DIM]) { in intersects()
280 if (s1.origin[DIM] < s2.origin[DIM]) { in lessThan()
283 if (s1.origin[DIM] > s2.origin[DIM]) { in lessThan()
441 Coord<DIM> dia = Coord<DIM>::diagonal(width);
[all …]
/dports/devel/ga/ga-5.8/global/testing/unit-tests/
H A Dga_create_irreg.c16 #define DIM 2 macro
24 …int dims[DIM]={5,10}, dims2[DIM], ndim, type, value=5, block[DIM]={2,3}, map[5]={0,2,0,4,6}, val=7; in irregular_array1()
25 int n_block[DIM], block_dims[DIM], i; in irregular_array1()
54 int dims[DIM]={GSIZE,GSIZE}, dims2[DIM], block[DIM]={3,2}, map[5]={0,2,6,0,4}, val=7; in irregular_array2()
55 int n_block[DIM], block_dims[DIM], i; in irregular_array2()
80 int dims[DIM]={GSIZE, GSIZE}, dims2[DIM], block[DIM], *map=NULL, val=7; in auto_number1()
81 int n_block[DIM], block_dims[DIM], b_temp, i; in auto_number1()
85 b1=DIM+inc; in auto_number1()
128 int dims[DIM]={GSIZE, GSIZE}, dims2[DIM], block[DIM], *map=NULL, val=7; in auto_number2()
129 int n_block[DIM], block_dims[DIM], b_temp, i; in auto_number2()
[all …]

12345678910>>...130