Home
last modified time | relevance | path

Searched refs:n_f (Results 1 – 25 of 171) sorted by relevance

1234567

/dports/science/frontistr/FrontISTR-c66bdc397de319ca59a0565b3f3b1a3b33f0c50c/hecmw1/src/visualizer/
H A Dhecmw_vis_color_composite_sf.c28 n_norm = sqrt(n_f[0] * n_f[0] + n_f[1] * n_f[1] + n_f[2] * n_f[2]); in find_surface_point()
38 nv_sign = n_f[0] * v_f[0] + n_f[1] * v_f[1] + n_f[2] * v_f[2]; in find_surface_point()
43 n_f[3] = -n_f[0] * fp[0][0] - n_f[1] * fp[0][1] - n_f[2] * fp[0][2]; in find_surface_point()
50 t = (-n_f[3] - n_f[0] * view_point_d[0] - n_f[1] * view_point_d[1] - in find_surface_point()
146 n_norm = sqrt(n_f[0] * n_f[0] + n_f[1] * n_f[1] + n_f[2] * n_f[2]); in find_point_depth()
156 nv_sign = n_f[0] * v_f[0] + n_f[1] * v_f[1] + n_f[2] * v_f[2]; in find_point_depth()
161 n_f[3] = -n_f[0] * fp[0][0] - n_f[1] * fp[0][1] - n_f[2] * fp[0][2]; in find_point_depth()
167 t = (-n_f[3] - n_f[0] * view_point_d[0] - n_f[1] * view_point_d[1] - in find_point_depth()
196 n_norm = sqrt(n_f[0] * n_f[0] + n_f[1] * n_f[1] + n_f[2] * n_f[2]); in find2_point_depth()
205 nv_sign = n_f[0] * v_f[0] + n_f[1] * v_f[1] + n_f[2] * v_f[2]; in find2_point_depth()
[all …]
H A Dhecmw_vis_new_refine.c175 n_norm = sqrt(n_f[0] * n_f[0] + n_f[1] * n_f[1] + n_f[2] * n_f[2]); in judge_inner_voxel_361()
187 sign_f = n_f[0] * c_c[0] + n_f[1] * c_c[1] + n_f[2] * c_c[2]; in judge_inner_voxel_361()
196 sign_p = p_c[0] * n_f[0] + p_c[1] * n_f[1] + p_c[2] * n_f[2]; in judge_inner_voxel_361()
232 n_norm = sqrt(n_f[0] * n_f[0] + n_f[1] * n_f[1] + n_f[2] * n_f[2]); in judge_inner_voxel_351()
244 sign_f = n_f[0] * c_c[0] + n_f[1] * c_c[1] + n_f[2] * c_c[2]; in judge_inner_voxel_351()
253 sign_p = p_c[0] * n_f[0] + p_c[1] * n_f[1] + p_c[2] * n_f[2]; in judge_inner_voxel_351()
271 n_norm = sqrt(n_f[0] * n_f[0] + n_f[1] * n_f[1] + n_f[2] * n_f[2]); in judge_inner_voxel_351()
283 sign_f = n_f[0] * c_c[0] + n_f[1] * c_c[1] + n_f[2] * c_c[2]; in judge_inner_voxel_351()
292 sign_p = p_c[0] * n_f[0] + p_c[1] * n_f[1] + p_c[2] * n_f[2]; in judge_inner_voxel_351()
346 n_norm = sqrt(n_f[0] * n_f[0] + n_f[1] * n_f[1] + n_f[2] * n_f[2]); in judge_inner_voxel_341()
[all …]
H A Dhecmw_vis_tetra_intersect.c222 n_f[0] = (fp[1][1] - fp[0][1]) * (fp[2][2] - fp[0][2]) - in find_intersection_tetra()
226 n_f[2] = (fp[1][0] - fp[0][0]) * (fp[2][1] - fp[0][1]) - in find_intersection_tetra()
229 n_norm = sqrt(n_f[0] * n_f[0] + n_f[1] * n_f[1] + n_f[2] * n_f[2]); in find_intersection_tetra()
231 for (j = 0; j < 3; j++) n_f[j] /= n_norm; in find_intersection_tetra()
241 sign_f = n_f[0] * c_c[0] + n_f[1] * c_c[1] + n_f[2] * c_c[2]; in find_intersection_tetra()
275 n_norm = sqrt(n_f[0] * n_f[0] + n_f[1] * n_f[1] + n_f[2] * n_f[2]); in find_intersection_tetra()
277 for (j = 0; j < 3; j++) n_f[j] /= n_norm; in find_intersection_tetra()
287 sign_f = n_f[0] * c_c[0] + n_f[1] * c_c[1] + n_f[2] * c_c[2]; in find_intersection_tetra()
389 n_norm = sqrt(n_f[0] * n_f[0] + n_f[1] * n_f[1] + n_f[2] * n_f[2]); in find_intersection_tetra()
391 for (j = 0; j < 3; j++) n_f[j] /= n_norm; in find_intersection_tetra()
[all …]
H A Dhecmw_vis_color_composite_vr.c259 n_norm = sqrt(n_f[0] * n_f[0] + n_f[1] * n_f[1] + n_f[2] * n_f[2]); in find_surface_point()
261 for (j = 0; j < 3; j++) n_f[j] /= n_norm; in find_surface_point()
268 nv_sign = n_f[0] * v_f[0] + n_f[1] * v_f[1] + n_f[2] * v_f[2]; in find_surface_point()
270 for (i = 0; i < 3; i++) n_f[i] = -n_f[i]; in find_surface_point()
272 n_f[3] = -n_f[0] * fp[0][0] - n_f[1] * fp[0][1] - n_f[2] * fp[0][2]; in find_surface_point()
274 if (fabs(n_f[0] * (out[0] - in[0]) + n_f[1] * (out[1] - in[1]) + in find_surface_point()
275 n_f[2] * (out[2] - in[2])) > EPSILON) { in find_surface_point()
276 t = (-n_f[3] - n_f[0] * in[0] - n_f[1] * in[1] - n_f[2] * in[2]) / in find_surface_point()
277 (n_f[0] * (out[0] - in[0]) + n_f[1] * (out[1] - in[1]) + in find_surface_point()
278 n_f[2] * (out[2] - in[2])); in find_surface_point()
[all …]
H A Dhecmw_vis_define_parameters.c124 for (j = 0; j < 3; j++) n_f[i][j] = f[i][j]; in transform_frame3()
127 for (j = 0; j < 3; j++) n_f[i][j] -= screen_point[j]; in transform_frame3()
130 xx = n_f[i][0]; in transform_frame3()
131 yy = n_f[i][1]; in transform_frame3()
132 zz = n_f[i][2]; in transform_frame3()
133 n_f[i][0] = xx * coff_matrix[0][0] + yy * coff_matrix[1][0] + in transform_frame3()
291 if (fabs(n_f[i][2] - view_point[2]) < EPSILON) in find_projection_range2()
295 view_point[2] / (n_f[i][2] - view_point[2]) * in find_projection_range2()
296 (n_f[i][0] - view_point[0]); in find_projection_range2()
298 view_point[2] / (n_f[i][2] - view_point[2]) * in find_projection_range2()
[all …]
H A Dhecmw_vis_color_composite_sf.h10 double view_point_d[3], double point[3], double n_f[4],
14 double n_f[4], double point[3], int normal_flag);
H A Dhecmw_vis_define_parameters.h16 double coff_matrix[3][3], double n_f[3][3]);
24 void find_projection_range2(double view_point[3], double n_f[3][3],
/dports/science/pagmo2/pagmo2-2.18.0/include/pagmo/utils/
H A Dmulti_objective.hpp132 if (n_f > n_w) { in decomposition_weights()
140 if (n_f < 2u) { in decomposition_weights()
153 if (n_f == 2u) { in decomposition_weights()
155 } else if (n_f == 3u) { in decomposition_weights()
159 while (binomial_coefficient(H + n_f - 1u, n_f - 1u) <= static_cast<double>(n_w)) { in decomposition_weights()
169 << binomial_coefficient(H + n_f - 1u, n_f - 1u) << " or " in decomposition_weights()
170 << binomial_coefficient(H + n_f, n_f - 1u) << " is possible."; in decomposition_weights()
184 for (decltype(n_f) i = 0u; i < n_f; ++i) { in decomposition_weights()
189 halton ld_seq{boost::numeric_cast<unsigned>(n_f - 1u), boost::numeric_cast<unsigned>(n_f)}; in decomposition_weights()
195 for (decltype(n_f) i = 0u; i < n_f; ++i) { in decomposition_weights()
[all …]
/dports/science/pagmo2/pagmo2-2.18.0/src/algorithms/
H A Dmaco.cpp217 for (decltype(n_f) i_nf = 0u; i_nf < n_f; ++i_nf) { in evolve()
231 for (decltype(n_f) i_f = 0; i_f < n_f; ++i_f) { in evolve()
247 for (decltype(n_f) i_nf = 0u; i_nf < n_f; ++i_nf) { in evolve()
262 for (decltype(n_f) i = 0u; i < n_f; ++i) { in evolve()
270 for (decltype(n_f) i = 0u; i < n_f; ++i) { in evolve()
291 for (decltype(n_f) i = 0u; i < n_f && check == false; ++i) { in evolve()
367 for (decltype(n_f) i_nf = 0u; i_nf < n_f; ++i_nf) { in evolve()
380 for (decltype(n_f) i_f = 0; i_f < n_f; ++i_f) { in evolve()
396 for (decltype(n_f) i_nf = 0u; i_nf < n_f; ++i_nf) { in evolve()
494 for (decltype(n_f) ii_f = 0u; ii_f < n_f; ++ii_f) { in evolve()
[all …]
H A Dgaco.cpp118 auto n_f = prob.get_nf(); // n_f=prob.get_nobj()+prob.get_nec()+prob.get_nic() in evolve() local
121 std::vector<vector_double> sol_archive(m_ker, vector_double(1 + n_x + n_f, 1)); in evolve()
133 vector_double fitness(n_f); in evolve()
135 vector_double fitness_final(n_f); in evolve()
220 for (decltype(n_f) j = 0; j < n_f; ++j) { in evolve()
304 for (decltype(n_f) ii_f = 0u; ii_f < n_f; ++ii_f) { in evolve()
402 for (decltype(n_f) ii_f = 0u; ii_f < n_f; ++ii_f) { in evolve()
/dports/science/apbs/apbs-pdb2pqr-apbs-1.5-102-g500c1473/apbs/externals/fetk/gamer/src/biom/
H A DGenerateSphereMesh.C65 int n_v, n_f; in SurfaceMesh_sphere() local
85 n_f = 8; in SurfaceMesh_sphere()
133 surfmesh->nf = n_f; in SurfaceMesh_sphere()
233 surfmesh->face[n_f].a = a; in SurfaceMesh_sphere()
234 surfmesh->face[n_f].b = e; in SurfaceMesh_sphere()
235 surfmesh->face[n_f].c = g; in SurfaceMesh_sphere()
236 n_f++; in SurfaceMesh_sphere()
237 surfmesh->face[n_f].a = e; in SurfaceMesh_sphere()
240 n_f++; in SurfaceMesh_sphere()
244 n_f++; in SurfaceMesh_sphere()
[all …]
/dports/lang/pcc/pcc-1.1.0/mip/
H A Dnode.h117 } n_f; member
129 #define n_left n_f.n_u.n_l._left
130 #define n_lval n_f.n_u.n_l._lval
131 #define n_slval n_f.n_u.n_l._slval
132 #define n_right n_f.n_u.n_r._right
133 #define n_rval n_f.n_u.n_r._rval
134 #define n_sp n_f.n_u.n_r._sp
135 #define n_dcon n_f._dcon
/dports/math/alberta/alberta3-920315ae1bbfd1b1fb6672d916619ac37a411e95/alberta/src/3d/
H A Dparametric_3d.c1972 int n_f, n_e; in project_face_nodesY_3d() local
1980 n_f = Ydata->n_f; in project_face_nodesY_3d()
2037 int n_f = Ydata->n_f; in adjust_face_nodesY_3d() local
2047 REAL_D adj[n_f]; in adjust_face_nodesY_3d()
2172 int n_f = Ydata->n_f; in adjust_center_nodesY_3d() local
2413 int n_f = Ydata->n_f; in adjust_patch_center_nodesY_3d() local
2508 int n_f = Ydata->n_f; in adjust_patch_wall_nodesY_3d() local
2742 if (n_f > 0) { in make_affineY_3d()
2783 int n_f = Ydata->n_f; in all_projectY_3d() local
2921 int n_f = Ydata->n_f; in adjust_projected_edgesY_3d() local
[all …]
/dports/textproc/rnv/rnv-1.7.11/
H A Drnd.c14 static int len_f,n_f; variable
66 flat=(int*)m_alloc(len_f=LEN_F,sizeof(int)); n_f=0; in deref()
86 if(n_f+2>len_f) flat=(int*)m_stretch(flat,len_f=2*(n_f+2),n_f,sizeof(int)); in deref()
98 if(n_f+1>len_f) flat=(int*)m_stretch(flat,len_f=2*(n_f+1),n_f,sizeof(int)); in deref()
108 } while(i!=n_f); in deref()
109 for(i=0;i!=n_f;++i) rn_unmark(flat[i]); in deref()
153 if(i==n_f) return; in loops()
193 for(i=0;i!=n_f;++i) { in ctypes()
355 for(i=0;i!=n_f;++i) { in paths()
374 for(i=0;i!=n_f;++i) { in nullables()
[all …]
/dports/graphics/pcl-pointclouds/pcl-pcl-1.12.0/geometry/include/pcl/geometry/
H A Dmesh_io.h98 int n_v = -1, n_he = -1, n_f = -1; in read() local
114 if (!(iss >> n_v >> n_he >> n_f) || iss.good()) // Don't allow more than 3 en in read()
121 if (n_v < 0 || n_he < 0 || n_f < 0) { in read()
177 mesh.faces_.reserve(n_f); in read()
180 for (int i = 0; i < n_f; ++i, ++line_number) { in read()
205 mesh.face_data_cloud_.resize(n_f); in read()
/dports/science/openems/openEMS-0.0.35-71-g4c24b6e/python/openEMS/
H A Dutilities.py25 for n_f in range(len(freq)):
26 f_val[n_f] = np.sum( val*np.exp( -1j*2*np.pi*freq[n_f] * t ) )
/dports/science/PETSc/petsc-3.14.1/src/dm/impls/da/
H A Ddainterp.c335 for (j=j_start; j<j_start+n_f; j++) { in DMCreateInterpolation_DA_2D_Q1()
386 for (j=j_start; j<j_start+n_f; j++) { in DMCreateInterpolation_DA_2D_Q1()
444 for (j=j_start; j<j_start+n_f; j++) { in DMCreateInterpolation_DA_2D_Q1()
563 for (j=j_start; j<j_start+n_f; j++) { in DMCreateInterpolation_DA_2D_Q0()
606 for (j=j_start; j<j_start+n_f; j++) { in DMCreateInterpolation_DA_2D_Q0()
628 ierr = PetscLogFlops(13.0*m_f*n_f);CHKERRQ(ierr); in DMCreateInterpolation_DA_2D_Q0()
694 for (j=j_start; j<j_start+n_f; j++) { in DMCreateInterpolation_DA_3D_Q0()
742 for (j=j_start; j<j_start+n_f; j++) { in DMCreateInterpolation_DA_3D_Q0()
837 for (j=j_start; j<j_start+n_f; j++) { in DMCreateInterpolation_DA_3D_Q1()
905 for (j=j_start; j<j_start+n_f; j++) { in DMCreateInterpolation_DA_3D_Q1()
[all …]
/dports/net/rssguard/rssguard-4.0.4/src/librssguard/core/
H A Dfeeddownloader.cpp151 auto n_f = m_feeds.takeFirst();
153 updateOneFeed(n_f->getParentServiceRoot(), in integrityProtectionMode()
154 n_f, in integrityProtectionMode()
155 stated_messages.value(n_f->getParentServiceRoot()).value(n_f->customId()), in integrityProtectionMode()
156 tagged_messages.value(n_f->getParentServiceRoot())); in integrityProtectionMode()
/dports/science/py-scikit-learn/scikit-learn-1.0.2/sklearn/datasets/
H A D_svmlight_format_io.py343 n_f = max(ind[1].max() if len(ind[1]) else 0 for ind in r) + 1
346 n_features = n_f
347 elif n_features < n_f:
350 n_features, n_f
/dports/biology/ugene/ugene-40.1/src/plugins_3rdparty/primer3/src/primer3_core/
H A Dprimer3_main.c358 n_f, n_r, n_m, cancelFlag, progress, ctx) in pr_choice() argument
380 PR_ASSERT(NULL != n_f);
383 PR_ASSERT(0 == *n_f);
559 int *n_f, *n_r;
678 *n_f = k;
741 sa->left_expl.ok = *n_f;
1302 int n_f;
1331 n_last = n_f;
2428 free_repeat_sim_score(n_f, n_r, n_m, ctx) in free_repeat_sim_score() argument
2429 int n_f, n_r, n_m; in free_repeat_sim_score()
[all …]
/dports/math/vtk8/VTK-8.2.0/Filters/General/
H A DvtkCurvatures.cxx75 double n_f[3]; // normal of facet (could be stored for later?) in GetMeanCurvature() local
127 facet->ComputeNormal(ore,end,oth,n_f); in GetMeanCurvature()
142 cs = double(vtkMath::Dot(n_f,n_n)); in GetMeanCurvature()
144 vtkMath::Cross(n_f,n_n,t); in GetMeanCurvature()
/dports/math/vtk9/VTK-9.1.0/Filters/General/
H A DvtkCurvatures.cxx90 double n_f[3]; // normal of facet (could be stored for later?) in GetMeanCurvature() local
143 vtkTriangle::ComputeNormal(ore, end, oth, n_f); in GetMeanCurvature()
162 const double cs = vtkMath::Dot(n_f, n_n); in GetMeanCurvature()
164 vtkMath::Cross(n_f, n_n, t); in GetMeanCurvature()
/dports/math/vtk6/VTK-6.2.0/Filters/General/
H A DvtkCurvatures.cxx75 double n_f[3]; // normal of facet (could be stored for later?) in GetMeanCurvature() local
127 facet->ComputeNormal(ore,end,oth,n_f); in GetMeanCurvature()
142 cs = double(vtkMath::Dot(n_f,n_n)); in GetMeanCurvature()
144 vtkMath::Cross(n_f,n_n,t); in GetMeanCurvature()
/dports/science/code_saturne/code_saturne-7.1.0/src/cdo/
H A Dcs_cdofb_vecteq.c1075 const short int n_f = cm->n_fc; in cs_cdofb_vecteq_solve_implicit() local
1105 cs_sdm_t *acc = cs_sdm_get_block(csys->mat, n_f, n_f); in cs_cdofb_vecteq_solve_implicit()
1109 csys->rhs[3*n_f + k] += ptyc * csys->val_n[3*n_f+k]; in cs_cdofb_vecteq_solve_implicit()
1335 const short int n_f = cm->n_fc; in cs_cdofb_vecteq_solve_theta() local
1351 csys->rhs[3*n_f + k] += tcoef * eqc->source_terms[3*c_id + k]; in cs_cdofb_vecteq_solve_theta()
1398 cs_sdm_t *acc = cs_sdm_get_block(csys->mat, n_f, n_f); in cs_cdofb_vecteq_solve_theta()
1402 csys->rhs[3*n_f + k] += ptyc * csys->val_n[3*n_f+k]; in cs_cdofb_vecteq_solve_theta()
/dports/graphics/gmt/gmt-6.3.0/src/potential/
H A Dokbfuns.h34 unsigned int n_f, *n_v, *ind; member

1234567