Home
last modified time | relevance | path

Searched refs:degree (Results 1 – 25 of 879) sorted by relevance

12345678910>>...36

/third_party/mindspore/mindspore/nn/wrap/
Dgrad_reducer.py83 def _tensors_allreduce(degree, mean, allgather, allreduce, allreduce_filter, grad): argument
101 grad = F.tensor_mul(grad, F.cast(degree, F.dtype(grad)))
107 def _tensors_allreduce_post(degree, mean, allreduce_filter, grad): argument
124 grad = F.tensor_mul(grad, F.cast(degree, F.dtype(grad)))
130 def _tensors_allreduce_ps(degree, mean, allgather, allreduce, allreduce_filter, grad, ps_parameter): argument
152 grad = F.tensor_mul(grad, F.cast(degree, F.dtype(grad)))
158 def _tensors_allreduce_with_sparse(degree, mean, allgather, allreduce, allreduce_filter, grad): argument
178 dout = F.tensor_mul(dout, F.cast(degree, F.dtype(dout)))
184 def _tensors_allreduce_with_sparse_ps(degree, mean, allgather, allreduce, allreduce_filter, grad, p… argument
208 dout = F.tensor_mul(dout, F.cast(degree, F.dtype(dout)))
[all …]
/third_party/boost/boost/graph/detail/
Dsparse_ordering.hpp58 : _size(0), Qsize(1), eccen(-1), degree(deg) in rcm_queue()
82 else if (get(degree, u) < get(degree, w)) in front()
92 else if (get(degree, u) < get(degree, w)) in front()
110 DegreeMap degree; member in boost::sparse::rcm_queue
142 Graph const& G, const Vertex& u, int& ecc, ColorMap color, DegreeMap degree) in pseudo_peripheral_pair() argument
147 sparse::rcm_queue< Vertex, DegreeMap > Q(degree); in pseudo_peripheral_pair()
166 Vertex find_starting_node(Graph const& G, Vertex r, Color color, Degree degree) in find_starting_node() argument
171 x = pseudo_peripheral_pair(G, r, eccen_r, color, degree); in find_starting_node()
172 y = pseudo_peripheral_pair(G, x, eccen_x, color, degree); in find_starting_node()
179 y = pseudo_peripheral_pair(G, x, eccen_x, color, degree); in find_starting_node()
/third_party/boost/boost/graph/
Dplod_generator.hpp43 , degree(0) in out_directed_plod_iterator()
50 degree = (xv == 0 ? 0 : std::size_t(beta * pow(xv, -alpha))); in out_directed_plod_iterator()
64 while (degree == 0) in operator ++()
75 degree = (xv == 0 ? 0 : std::size_t(beta * pow(xv, -alpha))); in operator ++()
82 --degree; in operator ++()
111 std::size_t degree; member in boost::out_directed_plod_iterator
145 std::size_t degree in undirected_plod_iterator() local
147 if (degree == 0) in undirected_plod_iterator()
148 degree = 1; in undirected_plod_iterator()
149 else if (degree >= n) in undirected_plod_iterator()
[all …]
Dcuthill_mckee_ordering.hpp34 : permutation(iter), Qptr(b), degree(deg) in bfs_rcm_visitor()
51 Compare comp(degree); in finish_vertex()
60 DegreeMap degree; member in boost::detail::bfs_rcm_visitor
74 OutputIterator permutation, ColorMap color, DegreeMap degree) in cuthill_mckee_ordering() argument
88 Visitor vis(&permutation, &Q, degree); in cuthill_mckee_ordering()
114 OutputIterator permutation, ColorMap color, DegreeMap degree) in cuthill_mckee_ordering() argument
121 return cuthill_mckee_ordering(g, vertex_queue, permutation, color, degree); in cuthill_mckee_ordering()
127 OutputIterator permutation, ColorMap color, DegreeMap degree) in cuthill_mckee_ordering() argument
155 *i = find_starting_node(G, *i, color, degree); in cuthill_mckee_ordering()
157 return cuthill_mckee_ordering(G, vertex_queue, permutation, color, degree); in cuthill_mckee_ordering()
Dking_ordering.hpp36 , degree(deg) in bfs_king_visitor()
77 put(degree, v, get(degree, v) - 1); in finish_vertex()
128 && get(degree, (*Qptr)[left_child]) in percolate_down()
129 > get(degree, (*Qptr)[right_child])) in percolate_down()
154 && get(degree, (*Qptr)[left_child]) in percolate_down()
155 > get(degree, (*Qptr)[right_child])) in percolate_down()
198 PseudoDegreeMap degree; member in boost::detail::bfs_king_visitor
212 OutputIterator permutation, ColorMap color, DegreeMap degree, in king_ordering() argument
238 put(pseudo_degree, *ui, get(degree, *ui)); in king_ordering()
270 OutputIterator permutation, ColorMap color, DegreeMap degree, in king_ordering() argument
[all …]
Dsmallest_last_ordering.hpp38 const VertexListGraph& G, Order order, Degree degree, Marker marker) in smallest_last_vertex_ordering() argument
52 BucketSorter degree_bucket_sorter(num, num, degree, get(vertex_index, G)); in smallest_last_vertex_ordering()
55 G, order, degree, marker, degree_bucket_sorter); in smallest_last_vertex_ordering()
61 Degree degree, Marker marker, BucketSorter& degree_buckets) in smallest_last_vertex_ordering() argument
74 put(degree, *v, out_degree(*v, G)); in smallest_last_vertex_ordering()
110 put(degree, *v, get(degree, *v) - 1); in smallest_last_vertex_ordering()
113 minimum_degree, get(degree, *v)); in smallest_last_vertex_ordering()
Dsloan_ordering.hpp105 ColorMap color, DegreeMap degree) in sloan_start_end_vertices() argument
118 Degree my_degree = get(degree, s); in sloan_start_end_vertices()
138 Compare comp(degree); in sloan_start_end_vertices()
147 dummy = get(degree, *ui); in sloan_start_end_vertices()
191 dummy = get(degree, *ui); in sloan_start_end_vertices()
264 OutputIterator permutation, ColorMap color, DegreeMap degree, in sloan_ordering() argument
299 cdeg = get(degree, *ui) + 1; in sloan_ordering()
407 OutputIterator permutation, ColorMap color, DegreeMap degree, in sloan_ordering() argument
411 g, s, e, permutation, color, degree, priority, WEIGHT1, WEIGHT2); in sloan_ordering()
424 Color color, Degree degree, Priority priority, Weight W1, Weight W2) in sloan_ordering() argument
[all …]
Dmake_maximal_planar.hpp57 , degree(degree_vector.begin(), vm) in triangulation_visitor()
61 put(degree, *vi, out_degree(*vi, g)); in triangulation_visitor()
92 degree_size_t deg = get(degree, *fi); in end_face()
164 put(degree, anchor, get(degree, anchor) + 1); in add_edge_range()
165 put(degree, v, get(degree, v) + 1); in add_edge_range()
177 vertex_to_degree_size_map_t degree; member
/third_party/boost/libs/geometry/test/core/
Dcoordinate_system.cpp79 test_all<bg::model::point<int, 2, bg::cs::spherical<bg::degree> >, in test_main()
80 bg::cs::spherical<bg::degree> >(); in test_main()
81 test_all<bg::model::point<float, 2, bg::cs::spherical<bg::degree> >, in test_main()
82 bg::cs::spherical<bg::degree> >(); in test_main()
83 test_all<bg::model::point<double, 2, bg::cs::spherical<bg::degree> >, in test_main()
84 bg::cs::spherical<bg::degree> >(); in test_main()
94 test_all<bg::model::point<double, 2, bg::cs::polar<bg::degree> >, in test_main()
95 bg::cs::polar<bg::degree> >(); in test_main()
97 test_all<bg::model::point<double, 2, bg::cs::geographic<bg::degree> >, in test_main()
98 bg::cs::geographic<bg::degree> >(); in test_main()
Dradian_access.cpp63 test_get<0, bg::model::point<T, 2, bg::cs::spherical<bg::degree> > > in test()
65 test_get<1, bg::model::point<T, 2, bg::cs::spherical<bg::degree> > > in test()
68 test_set<0, bg::model::point<T, 2, bg::cs::spherical<bg::degree> > > in test()
70 test_set<1, bg::model::point<T, 2, bg::cs::spherical<bg::degree> > > in test()
96 test_set<2, bg::model::point<T, 3, bg::cs::spherical<bg::degree> > > in test()
/third_party/mindspore/mindspore/ccsrc/backend/kernel_compiler/cpu/nnacl/base/
Dminimal_filtering_generator.c22 void Polynomial(const float *interval, float *m, int degree) { in Polynomial() argument
23 for (int i = 0; i < degree; ++i) { in Polynomial()
25 for (int j = 0; j < degree; ++j) { in Polynomial()
35 void DiagonalPlusMatrix(const float *matrix, float *diagonal_matrix, int degree) { in DiagonalPlusMatrix() argument
36 int data_num = (degree + 1) * (degree + 1); in DiagonalPlusMatrix()
38 for (int i = 0; i < degree; ++i) { in DiagonalPlusMatrix()
39 for (int j = 0; j < degree; ++j) { in DiagonalPlusMatrix()
41 diagonal_matrix[i * (degree + 1) + j] = matrix[i]; in DiagonalPlusMatrix()
149 void GenerateIntervalArray(float *array, float interval, int degree) { in GenerateIntervalArray() argument
151 for (int i = 1; i < degree; ++i) { in GenerateIntervalArray()
[all …]
/third_party/boost/libs/geometry/test/algorithms/length/
Dlength_sph.cpp67 bg::cs::spherical_equatorial<bg::degree> > >(); in test_main()
69 bg::cs::spherical_equatorial<bg::degree> > >(); in test_main()
71 bg::cs::spherical_equatorial<bg::degree> > >(); in test_main()
74 bg::cs::spherical_equatorial<bg::degree> > >(mean_radius); in test_main()
76 bg::cs::spherical_equatorial<bg::degree> > >(mean_radius); in test_main()
78 bg::cs::spherical_equatorial<bg::degree> > >(mean_radius); in test_main()
/third_party/boost/libs/geometry/test/algorithms/perimeter/
Dperimeter_sph.cpp70 bg::cs::spherical_equatorial<bg::degree> > >(); in test_main()
72 bg::cs::spherical_equatorial<bg::degree> > >(); in test_main()
74 bg::cs::spherical_equatorial<bg::degree> > >(); in test_main()
77 bg::cs::spherical_equatorial<bg::degree> > >(mean_radius); in test_main()
79 bg::cs::spherical_equatorial<bg::degree> > >(mean_radius); in test_main()
81 bg::cs::spherical_equatorial<bg::degree> > >(mean_radius); in test_main()
/third_party/skia/samplecode/
DSampleVariableWidthStroker.cpp61 explicit ScalarBezCurve(int degree) : fDegree(degree) { in ScalarBezCurve() argument
62 SkASSERT(degree >= 0); in ScalarBezCurve()
63 fWeights.resize(degree + 1, {0}); in ScalarBezCurve()
67 ScalarBezCurve(int degree, const std::vector<float>& weights) : ScalarBezCurve(degree) { in ScalarBezCurve() argument
68 SkASSERT(degree >= 0); in ScalarBezCurve()
69 SkASSERT(weights.size() == (size_t)degree + 1); in ScalarBezCurve()
124 const int degree = curve.fDegree; in Split() local
126 *left = ScalarBezCurve(degree); in Split()
127 *right = ScalarBezCurve(degree); in Split()
129 right->fWeights[degree] = curve.fWeights[degree]; in Split()
[all …]
/third_party/gstreamer/gstplugins_good/gst/audiofx/
Daudioinvert.c137 filter->degree = 0.0; in gst_audio_invert_init()
150 filter->degree = g_value_get_float (value); in gst_audio_invert_set_property()
152 filter->degree == 0.0); in gst_audio_invert_set_property()
168 g_value_set_float (value, filter->degree); in gst_audio_invert_get_property()
205 gfloat dry = 1.0 - filter->degree; in gst_audio_invert_transform_int()
209 val = (*data) * dry + (-1 - (*data)) * filter->degree; in gst_audio_invert_transform_int()
219 gfloat dry = 1.0 - filter->degree; in gst_audio_invert_transform_float()
223 val = (*data) * dry - (*data) * filter->degree; in gst_audio_invert_transform_float()
/third_party/boost/boost/math/tools/
Dpolynomial_gcd.hpp130 if (u.degree() < v.degree()) in subresultant_gcd()
138 BOOST_ASSERT(u.degree() >= v.degree()); in subresultant_gcd()
143 if (r.degree() == 0) in subresultant_gcd()
145 N const delta = u.degree() - v.degree(); in subresultant_gcd()
/third_party/boost/boost/gil/image_processing/
Dnumeric.hpp162 inline detail::kernel_2d<T, Allocator> generate_dx_sobel(unsigned int degree = 1) in generate_dx_sobel() argument
164 switch (degree) in generate_dx_sobel()
192 inline detail::kernel_2d<T, Allocator> generate_dx_scharr(unsigned int degree = 1) in generate_dx_scharr() argument
194 switch (degree) in generate_dx_scharr()
222 inline detail::kernel_2d<T, Allocator> generate_dy_sobel(unsigned int degree = 1) in generate_dy_sobel() argument
224 switch (degree) in generate_dy_sobel()
252 inline detail::kernel_2d<T, Allocator> generate_dy_scharr(unsigned int degree = 1) in generate_dy_scharr() argument
254 switch (degree) in generate_dy_scharr()
/third_party/boost/boost/random/
Dsobol.hpp64 const unsigned degree = multiprecision::msb(poly); // integer log2(poly) in resize() local
67 for (unsigned k = 0; k != degree; ++k) in resize()
72 for (unsigned j = degree; j < bit_count; ++j) in resize()
77 cj[bit_offset] = cj[dimension*(j-degree) + dim]; in resize()
78 for (unsigned k = 0; k != degree; ++k, p_i >>= 1) in resize()
80 int rem = degree - k; in resize()
/third_party/boost/libs/geometry/test/concepts/
Dpoint_well_formed_non_cartesian.cpp51 test_coordinate_system<bg::cs::geographic<bg::degree> >(); in main()
54 test_coordinate_system<bg::cs::spherical<bg::degree> >(); in main()
57 test_coordinate_system<bg::cs::spherical_equatorial<bg::degree> >(); in main()
60 test_coordinate_system<bg::cs::polar<bg::degree> >(); in main()
/third_party/boost/libs/graph/doc/
Dminimum_degree_ordering.w22 The minimum degree ordering algorithm \cite{LIU:MMD,George:evolution}
42 degree ordering algorithm is one such approach.
60 Mass elmination: if $y$ is selected as the minimum degree node then
61 the the vertices adjacent to $y$ with degree equal to $degree(y) - 1$
74 incomplete degree update
75 external degree
99 @d Insert vertices into bucket sorter (bucket number equals degree) @{
101 put(degree, *v, out_degree(*v, G));
107 @d Eliminate isolated nodes (nodes with zero degree) @{
119 @d Find first non-empty degree bucket
[all …]
/third_party/boost/libs/geometry/doc/generated/
Ddegree.qbk16 [section:degree degree]
18 '''<indexterm><primary>degree</primary></indexterm>'''
25 ``struct degree
/third_party/skia/third_party/externals/opengl-registry/extensions/ARB/
DARB_texture_filter_anisotropic.txt56 or -sampler object basis the maximum degree of anisotropy to account for
59 Increasing the maximum degree of anisotropy may
62 to clamp the specified degree of anisotropy to the implementation's
63 maximum supported degree of anisotropy.
65 A sampler or texture's maximum degree of anisotropy is specified
71 degree of anisotropy of two could be treated as a 2-tap filter that
78 filter, a LINEAR magnification filter, and a large maximum degree
123 should use a texture filtering scheme that accounts for a degree
229 TEXTURE_MAX_ANISOTROPY R GetTexParameterfv 1.0 Maximum degree 8.14 textu…
236 TEXTURE_MAX_ANISOTROPY R GetSamplerParameterfv 1.0 Maximum degree 8.14 -
[all …]
/third_party/boost/libs/geometry/doc/reference/algorithms/
Dtransform.qbk20 [[__sph__ (degree) / __sph__ (radian)][Transforms coordinates from degree to radian, or vice versa]]
22 [[__sph__ (degree, with radius) / __sph__ (radian, with radius)][Transforms coordinates from degree
/third_party/cmsis/CMSIS/DSP/Source/SVMFunctions/
Darm_svm_polynomial_init_f32.c77 int32_t degree, in arm_svm_polynomial_init_f32() argument
88 S->degree = degree; in arm_svm_polynomial_init_f32()
Darm_svm_polynomial_init_f16.c80 int32_t degree, in arm_svm_polynomial_init_f16() argument
91 S->degree = degree; in arm_svm_polynomial_init_f16()

12345678910>>...36