Home
last modified time | relevance | path

Searched refs:weights (Results 1 – 25 of 6889) sorted by relevance

12345678910>>...276

/dports/graphics/krita/krita-4.4.8/libs/pigment/tests/
H A DTestKoColorSpaceAbstract.cpp68 qint16 weights[2]; in testMixColorsOpU8() local
73 weights[0] = 255; in testMixColorsOpU8()
74 weights[1] = 0; in testMixColorsOpU8()
86 weights[0] = 0; in testMixColorsOpU8()
87 weights[1] = 255; in testMixColorsOpU8()
99 weights[0] = 128; in testMixColorsOpU8()
100 weights[1] = 127; in testMixColorsOpU8()
138 weights[0] = 89; in testMixColorsOpU8()
180 weights[1] = 0; in testMixColorsOpF32()
192 weights[0] = 0; in testMixColorsOpF32()
[all …]
/dports/editors/calligra/calligra-3.2.1/libs/pigment/tests/
H A DTestKoColorSpaceAbstract.cpp14 return (weights[0] * alpha1 + weights[1] * alpha2) / sumOfWeights; in mixOpExpectedAlpha()
34 return ((weights[0] * color1) + (weights[1] * color2)) / sumOfWeights; in mixOpNoAlphaExpectedColor()
59 qint16 weights[2]; in testMixColorsOpU8() local
64 weights[0] = 255; in testMixColorsOpU8()
65 weights[1] = 0; in testMixColorsOpU8()
77 weights[0] = 0; in testMixColorsOpU8()
78 weights[1] = 255; in testMixColorsOpU8()
90 weights[0] = 128; in testMixColorsOpU8()
129 weights[0] = 89; in testMixColorsOpU8()
171 weights[1] = 0; in testMixColorsOpF32()
[all …]
/dports/math/py-cma/cma-3.1.0/cma/
H A Drecombination_weights.py160 weights = len_
215 weights = self
216 assert all(weights[i] >= weights[i+1]
317 (sum(weights), -sum(weights[self.mu:])))
326 assert weights[-1] < 0 and weights[self.mu] <= 0
347 weights = self
351 assert all(weights[i] >= weights[i+1]
354 assert weights[self.mu-1] > 0 >= weights[self.mu]
357 sum(weights[:self.mu])**2 / sum(w**2 for w in weights[:self.mu]) <
361 sum(weights[self.mu:])**2 / sum(w**2 for w in weights[self.mu:]) <
[all …]
/dports/math/py-or-tools/or-tools-9.2/examples/flatzinc/
H A Dbroken_weights.fzn161 array [1..4] of var 1..40: weights :: output_array([1..4]);
163 constraint int_le(weights[1], weights[2]);
164 constraint int_le(weights[2], weights[3]);
165 constraint int_le(weights[3], weights[4]);
206 constraint int_lin_eq([1, 1, 1, 1], [weights[1], weights[2], weights[3], weights[4]], 40);
207 constraint int_times(x[1], weights[1], INT____00001) :: defines_var(INT____00001);
208 constraint int_times(x[2], weights[2], INT____00002) :: defines_var(INT____00002);
209 constraint int_times(x[3], weights[3], INT____00003) :: defines_var(INT____00003);
210 constraint int_times(x[4], weights[4], INT____00004) :: defines_var(INT____00004);
211 constraint int_times(x[5], weights[1], INT____00005) :: defines_var(INT____00005);
[all …]
/dports/devel/py-xarray/xarray-0.20.1/xarray/tests/
H A Dtest_weighted.py82 weights = DataArray(weights)
97 weights = DataArray(weights)
139 weights = DataArray(weights)
154 weights = DataArray(weights)
189 weights = DataArray(weights)
204 weights = DataArray(weights)
234 weights = DataArray(weights)
249 weights = DataArray(weights)
281 weights = DataArray(weights)
295 weights = DataArray(weights)
[all …]
/dports/www/grafana8/grafana-8.3.6/vendor/gonum.org/v1/gonum/stat/
H A Dstat.go64 if weights != nil && len(x) != len(weights) {
134 if weights != nil && len(x) != len(weights) {
263 weight := weights[i] * weights[j]
435 if weights != nil && len(x) != len(weights) {
485 if weights != nil && len(x) != len(weights) {
753 if weights != nil && len(weights) != len(x) {
793 if weights != nil && len(weights) != len(x) {
825 if weights != nil && len(weights) != len(values) {
857 if weights != nil && len(weights) != len(x) {
901 if weights != nil && len(x) != len(weights) {
[all …]
/dports/sysutils/istio/istio-1.6.7/vendor/github.com/openshift/api/vendor/gonum.org/v1/gonum/stat/
H A Dstat.go64 if weights != nil && len(x) != len(weights) {
134 if weights != nil && len(x) != len(weights) {
263 weight := weights[i] * weights[j]
435 if weights != nil && len(x) != len(weights) {
485 if weights != nil && len(x) != len(weights) {
753 if weights != nil && len(weights) != len(x) {
793 if weights != nil && len(weights) != len(x) {
825 if weights != nil && len(weights) != len(values) {
857 if weights != nil && len(weights) != len(x) {
901 if weights != nil && len(x) != len(weights) {
[all …]
/dports/math/mlpack/mlpack-3.4.2/src/mlpack/tests/
H A Dinit_rules_test.cpp43 arma::mat weights; in BOOST_AUTO_TEST_CASE() local
57 arma::mat weights; in BOOST_AUTO_TEST_CASE() local
62 weights *= weights.t(); in BOOST_AUTO_TEST_CASE()
69 weights = weights.t() * weights; in BOOST_AUTO_TEST_CASE()
81 arma::mat weights; in BOOST_AUTO_TEST_CASE() local
89 weights *= weights.t(); in BOOST_AUTO_TEST_CASE()
103 arma::mat weights; in BOOST_AUTO_TEST_CASE() local
119 arma::mat weights; in BOOST_AUTO_TEST_CASE() local
141 arma::mat weights; in BOOST_AUTO_TEST_CASE() local
162 arma::mat weights; in BOOST_AUTO_TEST_CASE() local
[all …]
/dports/math/R-cran-igraph/igraph/R/
H A Dstructural.properties.R89 weights <- as.numeric(weights)
112 weights <- as.numeric(weights)
141 weights <- as.numeric(weights)
410 weights <- as.numeric(weights)
476 weights <- as.numeric(weights)
542 weights <- as.numeric(weights)
713 weights <- as.numeric(weights)
816 weights <- as.numeric(weights)
956 weights <- as.numeric(weights)
2266 weights <- as.numeric(weights)
[all …]
/dports/x11/babl/babl-0.1.88/extensions/
H A DHCY.c198 luma = weights[0] * rgb[0] + weights[1] * rgb[1] + weights[2] * rgb[2]; in rgba_to_hcy_step()
205 Y_peak = weights[ix[2]] + X * weights[ix[1]]; in rgba_to_hcy_step()
245 Y_peak = weights[0] + H_insec * weights[1]; in hcy_to_rgba_step()
253 Y_peak = weights[1] + H_insec * weights[0]; in hcy_to_rgba_step()
261 Y_peak = weights[1] + H_insec * weights[2]; in hcy_to_rgba_step()
269 Y_peak = weights[2] + H_insec * weights[1]; in hcy_to_rgba_step()
277 Y_peak = weights[2] + H_insec * weights[0]; in hcy_to_rgba_step()
310 babl_space_get_rgb_luminance (space, &weights[0], &weights[1], &weights[2]); in rgba_to_hcya()
335 babl_space_get_rgb_luminance (space, &weights[0], &weights[1], &weights[2]); in hcya_to_rgba()
361 babl_space_get_rgb_luminance (space, &weights[0], &weights[1], &weights[2]); in rgba_to_hcy()
[all …]
/dports/graphics/mupdf/mupdf-1.18.0-source/source/fitz/
H A Ddraw-scale-simple.c235 if (!weights) in new_weights()
318 weights->index[index+k] = weights->index[index+k-1]; in add_weight()
348 int idx = weights->index[j - weights->patch_l]; in reorder_weights()
395 idx = weights->index[j - weights->patch_l]; in check_weights()
469 if (!weights) in make_weights()
492 cache->weights = weights; in make_weights()
500 const int *contrib = &weights->index[weights->index[0]]; in scale_row_to_temp()
1011 const int *contrib = &weights->index[weights->index[0]]; in scale_row_to_temp1()
1050 const int *contrib = &weights->index[weights->index[0]]; in scale_row_to_temp2()
1095 const int *contrib = &weights->index[weights->index[0]]; in scale_row_to_temp3()
[all …]
/dports/devel/R-cran-Hmisc/Hmisc/R/
H A Dwtd.stats.s7 weights <- weights[s]
10 sum(weights*x)/sum(weights)
24 weights <- weights[s]
28 weights <- weights*length(x)/sum(weights)
30 xbar <- sum(weights*x)/sum(weights)
128 weights <- weights[s]
133 weights <- weights*length(x)/sum(weights)
136 x <- x[i]; weights <- weights[i]
139 weights <- tapply(weights, x, sum)
145 weights <- weights[!is.na(weights)]
[all …]
/dports/cad/py-ezdxf/ezdxf-0.16.3/src/ezdxf/acc/
H A D_cpp_cubic_bezier.cpp24 weights[1] = 3.0 * _1_minus_t_square * t; in bernstein_poly_d0()
25 weights[2] = 3.0 * _1_minus_t * t2; in bernstein_poly_d0()
26 weights[3] = t2 * t; in bernstein_poly_d0()
35 weights[2] = 3.0 * t * (2.0 - 3.0 * t); in bernstein_poly_d1()
36 weights[3] = 3.0 * t2; in bernstein_poly_d1()
43 double weights[4]; in point() local
44 bernstein_poly_d0(t, weights); in point()
45 return p0 * weights[0] + p1 * weights[1] + p2 * weights[2] + p3 * weights[3]; in point()
51 double weights[4]; in tangent() local
52 bernstein_poly_d1(t, weights); in tangent()
[all …]
/dports/finance/R-cran-PerformanceAnalytics/PerformanceAnalytics/R/
H A DReturn.portfolio.R175 if(is.null(weights)){
182 weights = xts(matrix(weights, nrow=1), order.by=as.Date(start_date))
191 weights = checkData(weights, method="xts")
199 } else if(is.matrix(weights)&&length(intersect(names(R), colnames(weights)))!=0){
201 } else if(!is.matrix(weights)&&length(intersect(names(R), names(weights)))!=0){
223 weights=weights,
231 weights=weights,
263 if (i == nrow(weights)){
320 if(!isTRUE(all.equal(rowSums(weights), rep(1, NROW(weights))))){
323 weights$Residual = 1-rowSums(weights)
[all …]
/dports/math/py-statsmodels/statsmodels-0.13.1/statsmodels/base/
H A D_penalties.py41 self.weights = weights
88 return self.weights
143 self.weights = weights
312 super().__init__(tau, c=c, weights=weights)
322 weights = self.weights
323 self.weights = 1.
326 self.weights = weights
341 self.weights = 1.
362 self.weights = 1.
431 self.weights = weights
[all …]
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/source/simplex/
H A Dquadrature_lib.cc41 this->weights = quad.get_weights(); in PGauss()
49 this->weights.emplace_back(1.0); in PGauss()
59 this->weights.emplace_back(Q16); in PGauss()
60 this->weights.emplace_back(Q16); in PGauss()
61 this->weights.emplace_back(Q16); in PGauss()
77 this->weights.emplace_back(q12 * 0.225); in PGauss()
94 this->weights.emplace_back(Q16); in PGauss()
106 this->weights.emplace_back(Q124); in PGauss()
107 this->weights.emplace_back(Q124); in PGauss()
108 this->weights.emplace_back(Q124); in PGauss()
[all …]
/dports/math/igraph/igraph-0.9.5/examples/simple/
H A Digraph_laplacian.c71 igraph_vector_copy(weights, w); in test_unnormalized_laplacian()
90 if (weights) { in test_unnormalized_laplacian()
109 if (weights) { in test_unnormalized_laplacian()
126 if (weights) { in test_unnormalized_laplacian()
128 free(weights); in test_unnormalized_laplacian()
165 if (weights) { in test_normalized_laplacian()
183 if (weights) { in test_normalized_laplacian()
200 if (weights) { in test_normalized_laplacian()
202 free(weights); in test_normalized_laplacian()
217 igraph_vector_t weights; in main() local
[all …]
/dports/devel/py-rapidfuzz/rapidfuzz-1.8.0/src/rapidfuzz-cpp/rapidfuzz/
H A Dstring_metric.hpp164 if (weights.insert_cost == weights.delete_cost) {
171 if (weights.insert_cost == weights.replace_cost) {
183 else if (weights.replace_cost >= weights.insert_cost + weights.delete_cost) {
210 if (weights.insert_cost == weights.delete_cost) { in distance()
217 if (weights.insert_cost == weights.replace_cost) { in distance()
230 else if (weights.replace_cost >= weights.insert_cost + weights.delete_cost) { in distance()
329 if (weights.insert_cost == weights.delete_cost) {
331 if (weights.insert_cost == weights.replace_cost) {
338 else if (weights.replace_cost >= weights.insert_cost + weights.delete_cost) {
359 if (weights.insert_cost == weights.delete_cost) { in ratio()
[all …]
/dports/devel/rapidfuzz-cpp/rapidfuzz-cpp-47df6f7/rapidfuzz/
H A Dstring_metric.hpp165 if (weights.insert_cost == weights.delete_cost) {
172 if (weights.insert_cost == weights.replace_cost) {
182 else if (weights.replace_cost >= weights.insert_cost + weights.delete_cost) {
205 if (weights.insert_cost == weights.delete_cost) { in distance()
212 if (weights.insert_cost == weights.replace_cost) { in distance()
222 else if (weights.replace_cost >= weights.insert_cost + weights.delete_cost) { in distance()
318 if (weights.insert_cost == weights.delete_cost) {
320 if (weights.insert_cost == weights.replace_cost) {
327 else if (weights.replace_cost >= weights.insert_cost + weights.delete_cost) {
347 if (weights.insert_cost == weights.delete_cost) { in ratio()
[all …]
/dports/math/R-cran-MatchIt/MatchIt/R/
H A Dweights.subclass.R8 weights <- setNames(rep(0, length(treat)), names(treat)) functionVar
23 weights[i1] <- 1
27 weights[i0] <- weights[i0]*sum(i0)/sum(weights[i0])
31 weights[i0] <- 1
34 weights[i1] <- weights[i1]*sum(i1)/sum(weights[i1])
41 weights[i1] <- weights[i1]*sum(i1)/sum(weights[i1])
42 weights[i0] <- weights[i0]*sum(i0)/sum(weights[i0])
45 if (sum(weights)==0)
47 else if (sum(weights[treat == 1])==0)
49 else if (sum(weights[treat == 0])==0)
[all …]
/dports/science/dakota/dakota-6.13.0-release-public.src-UI/packages/external/C3/src/lib_quadrature/
H A Dquadrature.c62 weights[0] = 0.5*h; in trap_w()
64 weights[ii] = 1.0*h; in trap_w()
66 weights[N-1] = 0.5*h; in trap_w()
67 return weights; in trap_w()
101 return weights; in simpson_w()
134 weights[0] = 2.0; in clenshaw_curtis()
149 weights[ii] = 1.0; in clenshaw_curtis()
163 weights[0] = weights[0] / (double) (N-1); in clenshaw_curtis()
165 weights[ii] = 2.0 * weights[ii] / (double) (N-1); in clenshaw_curtis()
167 weights[N-1] = weights[N-1] / (double) (N-1); in clenshaw_curtis()
[all …]
/dports/science/libgeodecomp/libgeodecomp-0.4.0/src/geometry/partitions/test/unit/
H A Drecursivebisectionpartitiontest.h16 std::vector<std::size_t> weights; in testSearchNodeCuboid() local
17 weights += 25, 25; in testSearchNodeCuboid()
22 weights += 50; in testSearchNodeCuboid()
27 weights += 200; in testSearchNodeCuboid()
31 weights += 100; in testSearchNodeCuboid()
39 weights += 200, 100, 50, 25, 25; in testGetRegion()
47 weights, in testGetRegion()
78 weights += 16, 16, 16, 16; in testDimWeights()
91 weights += 0, 0; in testDegradedDimensions()
98 weights), in testDegradedDimensions()
[all …]
/dports/astro/py-astropy/astropy-5.0/astropy/stats/
H A Dcircstats.py24 if weights is None:
25 weights = np.ones((1,))
27 weights = np.broadcast_to(weights, data.shape)
31 C = np.sum(weights * np.cos(p * (data - phi)), axis)/np.sum(weights, axis)
32 S = np.sum(weights * np.sin(p * (data - phi)), axis)/np.sum(weights, axis)
57 def circmean(data, axis=None, weights=None): argument
99 def circvar(data, axis=None, weights=None): argument
460 if weights is None:
461 weights = np.ones((1,))
463 weights = np.broadcast_to(weights, data.shape)
[all …]
/dports/science/code_saturne/code_saturne-7.1.0/src/cdo/
H A Dcs_quadrature.h570 *results += weights[0] * feval[0] + weights[1] * feval[1]; in cs_quadrature_edge_2pts_scal()
608 *results += weights[0]*feval[0] + weights[1]*feval[1] + weights[2]*feval[2]; in cs_quadrature_edge_3pts_scal()
688 results[0] += weights[0] * feval[0] + weights[1] * feval[3]; in cs_quadrature_edge_2pts_vect()
689 results[1] += weights[0] * feval[1] + weights[1] * feval[4]; in cs_quadrature_edge_2pts_vect()
690 results[2] += weights[0] * feval[2] + weights[1] * feval[5]; in cs_quadrature_edge_2pts_vect()
811 *results += weights[0] * evaluation[0] + weights[1] * evaluation[1] + in cs_quadrature_tria_3pts_scal()
850 *results += weights[0] * evaluation[0] + weights[1] * evaluation[1] + in cs_quadrature_tria_4pts_scal()
851 weights[2] * evaluation[2] + weights[3] * evaluation[3]; in cs_quadrature_tria_4pts_scal()
889 *results += weights[0] * evaluation[0] + weights[1] * evaluation[1] + in cs_quadrature_tria_7pts_scal()
890 weights[2] * evaluation[2] + weights[3] * evaluation[3] + in cs_quadrature_tria_7pts_scal()
[all …]
/dports/science/InsightToolkit/ITK-5.0.1/Modules/Core/ImageFunction/include/
H A DitkBSplineInterpolateImageFunction.hxx402 weights[n][0] = ( 1.0 / 6.0 ) + 0.5 * w * ( w - 1.0 ) - weights[n][3]; in SetInterpolationWeights()
403 weights[n][2] = w + weights[n][0] - 2.0 * weights[n][3]; in SetInterpolationWeights()
404 weights[n][1] = 1.0 - weights[n][0] - weights[n][2] - weights[n][3]; in SetInterpolationWeights()
421 weights[n][1] = w; in SetInterpolationWeights()
433 weights[n][2] = 0.5 * ( w - weights[n][1] + 1.0 ); in SetInterpolationWeights()
434 weights[n][0] = 1.0 - weights[n][1] - weights[n][2]; in SetInterpolationWeights()
447 weights[n][0] *= weights[n][0]; in SetInterpolationWeights()
448 weights[n][0] *= ( 1.0 / 24.0 ) * weights[n][0]; in SetInterpolationWeights()
453 weights[n][4] = weights[n][0] + t0 + 0.5 * w; in SetInterpolationWeights()
454 weights[n][2] = 1.0 - weights[n][0] - weights[n][1] - weights[n][3] - weights[n][4]; in SetInterpolationWeights()
[all …]

12345678910>>...276