Home
last modified time | relevance | path

Searched refs:yvals (Results 1 – 25 of 315) sorted by relevance

12345678910>>...13

/dports/science/cdo/cdo-2.0.0/src/mpim_grid/
H A Dgrid_proj.cc34 yvals[i] = val; in set_xyvals()
44 if (yvals[i] < -9000. || yvals[i] > 9000.) yvals[i] = -9999.; in check_xyvals()
77 p.uv.v = proj_torad(yvals[i]); in proj_fwd_xyvals()
81 yvals[i] = p.uv.v; in proj_fwd_xyvals()
100 p.uv.v = yvals[i]; in proj_inv_xyvals()
104 yvals[i] = proj_todeg(p.uv.v); in proj_inv_xyvals()
247 lonlat_to_lcc(gpp, nvals, xvals, yvals); in cdo_lonlat_to_lcc()
320 lcc_to_lonlat(gpp, nvals, xvals, yvals); in cdo_lcc_to_lonlat()
494 check_xyvals(nvals, xvals, yvals); in cdo_sinu_to_lonlat()
590 check_xyvals(nvals, xvals, yvals); in cdo_laea_to_lonlat()
[all …]
H A Dgrid_proj.h13 int cdo_lonlat_to_lcc(int gridID, size_t nvals, double *xvals, double *yvals);
14 int cdo_lcc_to_lonlat(int gridID, size_t nvals, double *xvals, double *yvals);
15 int cdo_stere_to_lonlat(int gridID, size_t nvals, double *xvals, double *yvals);
17 void cdo_sinu_to_lonlat(size_t nvals, double *xvals, double *yvals);
18 void cdo_laea_to_lonlat(int gridID, size_t nvals, double *xvals, double *yvals);
20 void cdo_proj_to_lonlat(char *proj_param, size_t nvals, double *xvals, double *yvals);
22 int proj_lonlat_to_lcc(struct CDI_GridProjParams gpp, size_t nvals, double *xvals, double *yvals);
23 …truct CDI_GridProjParams *gpp, double x_0, double y_0, size_t nvals, double *xvals, double *yvals);
25 int proj_lonlat_to_stere(struct CDI_GridProjParams gpp, size_t nvals, double *xvals, double *yvals);
26 …truct CDI_GridProjParams *gpp, double x_0, double y_0, size_t nvals, double *xvals, double *yvals);
/dports/science/cdo/cdo-2.0.0/src/
H A Dgriddes_h5.cc111 if (yvals[index2] > -90 && yvals[index2] < 90) in fill_gridvals()
113 ymax = yvals[index2]; in fill_gridvals()
121 if (yvals[index2] > -90 && yvals[index2] < 90) in fill_gridvals()
138 if (yvals[i] > -90 && yvals[i] < 90) in fill_gridvals()
140 if (yvals[i] < ymin) ymin = yvals[i]; in fill_gridvals()
141 if (yvals[i] > ymax) ymax = yvals[i]; in fill_gridvals()
206 if (yvals[index] < -90 || yvals[index] > 90) in fill_gridvals()
217 if (yvals[index2] > -90 && yvals[index2] < 90) in fill_gridvals()
219 yvals[index] = yvals[index2]; in fill_gridvals()
227 if (yvals[index2] > -90 && yvals[index2] < 90) in fill_gridvals()
[all …]
H A Dgrid_read_pingo.cc91 grid.yvals.resize(grid.ysize); in grid_read_pingo()
126 if (input_darray(gfp, 2, grid.yvals) != 2) return gridID; in grid_read_pingo()
127 …for (i = 0; i < (int) grid.ysize; i++) grid.yvals[i] = grid.yvals[0] + i * (grid.yvals[1] - grid.y… in grid_read_pingo()
131 if (input_darray(gfp, nlat, grid.yvals) != (size_t) nlat) return gridID; in grid_read_pingo()
136 …if (grid.yvals[0] > 90.001 || grid.yvals[nlat - 1] > 90.001 || grid.yvals[0] < -90.001 || grid.yva… in grid_read_pingo()
143 if (IS_EQUAL(grid.yvals[i + 1], grid.yvals[i]) in grid_read_pingo()
144 …|| (i < nlat - 2 && ((grid.yvals[i + 1] > grid.yvals[i]) != (grid.yvals[i + 2] > grid.yvals[i + 1]… in grid_read_pingo()
150 grid.type = is_gaussian_latitudes(nlat, grid.yvals.data()) ? GRID_GAUSSIAN : GRID_LONLAT; in grid_read_pingo()
H A DMaskbox.cc63 yvals[number] = ycoord; in read_coords()
67 …if ((number != 0) && (!(IS_EQUAL(xvals[0], xvals[number - 1]) && IS_EQUAL(yvals[0], yvals[number -… in read_coords()
70 yvals[number] = yvals[0]; in read_coords()
177 Varray<double> xvals(gridsize), yvals(gridsize); in maskbox_cell() local
179 gridInqYvals(gridID, yvals.data()); in maskbox_cell()
194 const auto yval = yvals[i]; in maskbox_cell()
257 const auto yval = yvals[ilat]; in mask_region_regular()
274 shared(gridsize, xvals, yvals, segmentSize, xcoords, ycoords, mask, xmm, ymm) in mask_region_cell()
278 const auto yval = yvals[i]; in mask_region_cell()
373 gridInqYvals(gridID, yvals.data()); in Maskbox()
[all …]
H A DVargen.cc123 Varray<double> xvals(nxvals), yvals(nyvals); in remap_nn_reg2d_to_reg2d() local
126 gridInqYvals(gridID, yvals.data()); in remap_nn_reg2d_to_reg2d()
137 const auto jj = calc_index_jj(ny, yvals[j]); in remap_nn_reg2d_to_reg2d()
151 Varray<double> xvals(gridsize), yvals(gridsize); in remap_nn_reg2d_to_nonreg2d() local
159 gridInqYvals(gridID2, yvals.data()); in remap_nn_reg2d_to_nonreg2d()
167 const auto jj = calc_index_jj(ny, yvals[i]); in remap_nn_reg2d_to_nonreg2d()
226 gcLLtoXYZ(xvals[i], yvals[i], xyz); in testfield_compute()
451 Varray<double> xvals(gridsize), yvals(gridsize); in Vargen() local
465 gridInqYvals(gridID, yvals.data()); in Vargen()
474 sincos_compute(gridsize, array, xvals, yvals); in Vargen()
[all …]
/dports/math/apache-commons-math/commons-math3-3.6.1-src/src/main/java/org/apache/commons/math3/analysis/interpolation/
H A DAkimaSplineInterpolator.java67 double[] yvals) in interpolate() argument
72 yvals == null) { in interpolate()
76 if (xvals.length != yvals.length) { in interpolate()
94 differences[i] = (yvals[i + 1] - yvals[i]) / (xvals[i + 1] - xvals[i]); in interpolate()
127 return interpolateHermiteSorted(xvals, yvals, firstDerivatives); in interpolate()
148 final double x0 = yvals[indexOfFirstSample]; in differentiateThreePoint()
149 final double x1 = yvals[indexOfSecondsample]; in differentiateThreePoint()
150 final double x2 = yvals[indexOfThirdSample]; in differentiateThreePoint()
175 if (xvals.length != yvals.length) { in interpolateHermiteSorted()
199 final double yv = yvals[i]; in interpolateHermiteSorted()
[all …]
/dports/math/vtk9/VTK-9.1.0/ThirdParty/vtkm/vtkvtkm/vtk-m/vtkm/cont/
H A DDataSetBuilderRectilinear.h57 std::vector<T> yvals(1, 0), zvals(1, 0);
66 T yvals = 0, zvals = 0; variable
74 vtkm::cont::ArrayHandle<T> yvals, zvals; variable
75 yvals.Allocate(1);
76 yvals.WritePortal().Set(0, 0.0);
85 const std::vector<T>& yvals,
96 T* yvals,
120 T* yvals,
154 DataSetBuilderRectilinear::CopyInto(yvals, Yc); in BuildDataSet()
165 const T* yvals, in BuildDataSet() argument
[all …]
/dports/math/vtk8/VTK-8.2.0/ThirdParty/vtkm/vtk-m/vtkm/cont/
H A DDataSetBuilderRectilinear.h66 std::vector<T> yvals(1, 0), zvals(1, 0);
76 T yvals = 0, zvals = 0; variable
78 nx, 1, 1, xvals, &yvals, &zvals, coordNm, cellNm);
86 vtkm::cont::ArrayHandle<T> yvals, zvals; variable
87 yvals.Allocate(1);
88 yvals.GetPortalControl().Set(0, 0.0);
109 T* yvals,
115 nx, ny, 1, xvals, yvals, &zvals, coordNm, cellNm);
136 T* yvals,
175 DataSetBuilderRectilinear::CopyInto(yvals, Yc); in BuildDataSet()
[all …]
/dports/science/cantera/cantera-2.5.1-611-gc4d6ecc15/ext/sundials/examples/sunnonlinsol/petsc/
H A Dtest_sunnonlinsol_petscsnes.c125 realtype yvals[3]; in main() local
127 VecGetValues(Y, 3, indc, yvals); in main()
131 printf("y1 = %"GSYM"\n", yvals[0]); in main()
132 printf("y2 = %"GSYM"\n", yvals[1]); in main()
133 printf("y3 = %"GSYM"\n", yvals[2]); in main()
137 printf("e1 = %"GSYM"\n", yvals[0] - Y1); in main()
138 printf("e2 = %"GSYM"\n", yvals[1] - Y2); in main()
139 printf("e3 = %"GSYM"\n", yvals[2] - Y3); in main()
219 realtype yvals[3]; in Jac() local
225 VecGetValues(y, 3, indc, yvals); in Jac()
[all …]
/dports/math/sundials/sundials-5.7.0/examples/sunnonlinsol/petsc/
H A Dtest_sunnonlinsol_petscsnes.c125 realtype yvals[3]; in main() local
127 VecGetValues(Y, 3, indc, yvals); in main()
131 printf("y1 = %"GSYM"\n", yvals[0]); in main()
132 printf("y2 = %"GSYM"\n", yvals[1]); in main()
133 printf("y3 = %"GSYM"\n", yvals[2]); in main()
137 printf("e1 = %"GSYM"\n", yvals[0] - Y1); in main()
138 printf("e2 = %"GSYM"\n", yvals[1] - Y2); in main()
139 printf("e3 = %"GSYM"\n", yvals[2] - Y3); in main()
219 realtype yvals[3]; in Jac() local
225 VecGetValues(y, 3, indc, yvals); in Jac()
[all …]
/dports/science/py-veusz/veusz-veusz-3.3.1/veusz/widgets/
H A Dfit.py95 dof = len(yvals) - len(params)
259 yvals = ydata.data
269 yserr = yvals*0.05
281 mask = N.logical_and(yvals >= drange[0], yvals <= drange[1])
282 xvals, yvals, yserr = xvals[mask], yvals[mask], yserr[mask]
303 mask = yvals >= s.min
304 xvals, yvals, yserr = xvals[mask], yvals[mask], yserr[mask]
311 mask = yvals <= s.max
312 xvals, yvals, yserr = xvals[mask], yvals[mask], yserr[mask]
332 yvals = yvals[finite]
[all …]
/dports/math/p5-Math-Utils/Math-Utils-1.14/eg/
H A Dfinitedif.pl11 my(@yvals);
22 @yvals = (0, 1);
25 push @yvals, ($yvals[$j - 1] + $j ** $power);
30 @yvals = @ARGV;
33 help() if ($helpme or ! scalar @yvals);
35 my @fc = diff_column(@yvals);
37 print_diff_triangle(diff_triangle(@yvals)) if ($triangle);
/dports/science/qmcpack/qmcpack-3.11.0/src/QMCTools/ppconvert/src/
H A DCubicSpline.h63 …inline void Init(SimpleGrid& newGrid, std::vector<double> yvals, double startderiv, double endderi… in Init() argument
67 if (newGrid.NumPoints() != yvals.size()) in Init()
71 std::cerr << "Y points = " << yvals.size() << std::endl; in Init()
77 y = yvals; in Init()
84 inline void Init(SimpleGrid& newGrid, std::vector<double>& yvals) in Init() argument
86 Init(newGrid, yvals, 5.0e30, 5.0e30); in Init()
91 inline CubSpline(SimpleGrid& newGrid, std::vector<double>& yvals) in CubSpline() argument
94 Init(newGrid, yvals, 5.0e30, 5.0e30); in CubSpline()
99 …inline CubSpline(SimpleGrid& newGrid, std::vector<double>& yvals, double startderiv, double endder… in CubSpline() argument
101 Init(newGrid, yvals, startderiv, endderiv); in CubSpline()
/dports/science/lammps/lammps-stable_29Sep2021/lib/kokkos/core/perf_test/
H A Drun_mempool.sh8 cat log | tail -n 1 | rev | cut -d ' ' -f 1 | rev >> yvals
13 rm -f xvals yvals
20 rm -f yvals$yset
21 mv yvals yvals$yset
/dports/devel/kokkos/kokkos-3.4.01/core/perf_test/
H A Drun_mempool.sh8 cat log | tail -n 1 | rev | cut -d ' ' -f 1 | rev >> yvals
13 rm -f xvals yvals
20 rm -f yvals$yset
21 mv yvals yvals$yset
/dports/science/sparta/sparta-20Oct2021/lib/kokkos/core/perf_test/
H A Drun_mempool.sh8 cat log | tail -n 1 | rev | cut -d ' ' -f 1 | rev >> yvals
13 rm -f xvals yvals
20 rm -f yvals$yset
21 mv yvals yvals$yset
/dports/graphics/processing/processing-1.5.1/modes/android/examples/Basics/Input/MouseSignals/
H A DMouseSignals.pde11 int[] yvals;
18 yvals = new int[width];
30 yvals[i-1] = yvals[i];
35 yvals[width-1] = mouseY;
50 point(i, height/3+yvals[i]/3);
/dports/graphics/processing/processing-1.5.1/modes/java/examples/Basics/Input/MouseSignals/
H A DMouseSignals.pde11 int[] yvals;
18 yvals = new int[width];
30 yvals[i-1] = yvals[i];
35 yvals[width-1] = mouseY;
50 point(i, height/3+yvals[i]/3);
/dports/biology/bcftools/bcftools-1.14/
H A Dpolysomy.c44 double *yvals; member
79 avg += dist->yvals[2*i-1]; in init_dist()
85 avg += dist->yvals[i]; in init_dist()
94 avg -= dist->yvals[i-hwin]; in init_dist()
113 if ( dist->yvals[imax_aa] < dist->yvals[i] ) imax_aa = i; in init_dist()
121 srr += dist->yvals[i]; in init_dist()
122 if ( max_rr < dist->yvals[i] ) max_rr = dist->yvals[i]; in init_dist()
126 sra += dist->yvals[i]; in init_dist()
127 if ( max_ra < dist->yvals[i] ) max_ra = dist->yvals[i]; in init_dist()
131 saa += dist->yvals[i]; in init_dist()
[all …]
H A Dpeakfit.c45 void (*calc_f) (int nvals, double *xvals, double *yvals, void *args);
59 double *xvals, *yvals, *vals; member
92 yvals[i] += scale2 * exp(-tmp*tmp); in bounded_gaussian_calc_f()
188 void gaussian_calc_f(int nvals, double *xvals, double *yvals, void *args) in gaussian_calc_f() argument
200 yvals[i] += scale2 * exp(-tmp*tmp); in gaussian_calc_f()
273 void exp_calc_f(int nvals, double *xvals, double *yvals, void *args) in exp_calc_f() argument
284 yvals[i] += scale2 * exp((xvals[i]-center)/sigma/sigma); in exp_calc_f()
407 gsl_vector_set(yvals, i, (pkf->vals[i] - pkf->yvals[i])/0.01); in peakfit_calc_f()
440 peakfit_calc_f(params, data, yvals); in peakfit_calc_fdf()
456 sum += fabs(pkf->vals[i] - pkf->yvals[i]); in peakfit_evaluate()
[all …]
/dports/biology/bio-mocha/bcftools-1.14/
H A Dpolysomy.c44 double *yvals; member
79 avg += dist->yvals[2*i-1]; in init_dist()
85 avg += dist->yvals[i]; in init_dist()
94 avg -= dist->yvals[i-hwin]; in init_dist()
113 if ( dist->yvals[imax_aa] < dist->yvals[i] ) imax_aa = i; in init_dist()
121 srr += dist->yvals[i]; in init_dist()
122 if ( max_rr < dist->yvals[i] ) max_rr = dist->yvals[i]; in init_dist()
126 sra += dist->yvals[i]; in init_dist()
127 if ( max_ra < dist->yvals[i] ) max_ra = dist->yvals[i]; in init_dist()
131 saa += dist->yvals[i]; in init_dist()
[all …]
H A Dpeakfit.c45 void (*calc_f) (int nvals, double *xvals, double *yvals, void *args);
59 double *xvals, *yvals, *vals; member
92 yvals[i] += scale2 * exp(-tmp*tmp); in bounded_gaussian_calc_f()
188 void gaussian_calc_f(int nvals, double *xvals, double *yvals, void *args) in gaussian_calc_f() argument
200 yvals[i] += scale2 * exp(-tmp*tmp); in gaussian_calc_f()
273 void exp_calc_f(int nvals, double *xvals, double *yvals, void *args) in exp_calc_f() argument
284 yvals[i] += scale2 * exp((xvals[i]-center)/sigma/sigma); in exp_calc_f()
407 gsl_vector_set(yvals, i, (pkf->vals[i] - pkf->yvals[i])/0.01); in peakfit_calc_f()
440 peakfit_calc_f(params, data, yvals); in peakfit_calc_fdf()
456 sum += fabs(pkf->vals[i] - pkf->yvals[i]); in peakfit_evaluate()
[all …]
/dports/graphics/py-pygal/pygal-2.4.0/pygal/graph/
H A Dxy.py49 def yvals(self): member in XY
60 else (min(self.yvals) if self.yvals else None))
66 else (max(self.yvals) if self.yvals else None))
86 if self.yvals:
110 self.yvals = [val[1]
/dports/science/qmcpack/qmcpack-3.11.0/src/Numerics/tests/
H A Dgen_cubic_spline.py169 def generate_cubic_spline_coeff_test_case(n, xvals, yvals, naturalBC=(True,True), argument
174 y_init_expr = convert_to_brace_list(yvals)
176 ysubs = {y[i]:yv for i,yv in enumerate(yvals)}
206 yvals = [1.0, 2.0, 1.5]
207 generate_cubic_spline_coeff_test_case(len(xvals), xvals, yvals, test_idx=1)
212 yvals = [1.0, 2.0, 1.5, 1.8]
213 generate_cubic_spline_coeff_test_case(len(xvals), xvals, yvals, test_idx=4)
278 yvals = [1.0, 2.0, 1.5]
286 ysubs = {y[i]:yv for i,yv in enumerate(yvals)}
322 y_expr = convert_to_brace_list(yvals)
[all …]

12345678910>>...13