Home
last modified time | relevance | path

Searched refs:cs_math_3_dot_product (Results 1 – 25 of 76) sorted by relevance

1234

/dports/science/code_saturne/code_saturne-7.1.0/src/mesh/
H A Dcs_geom.c135 return (cs_math_3_dot_product(disp, p) > 0 ? 1 : -1); in _test_edge()
327 double od_p = cs_math_3_dot_product(disp, pvec); in cs_geom_segment_intersect_face()
398 double og_p = - cs_math_3_dot_product(vgo, pvec); in cs_geom_segment_intersect_face()
H A Dcs_mesh_bad_cells.c159 cos_alpha = cs_math_3_dot_product(v1, v2); in _compute_ortho_norm()
200 cos_alpha = cs_math_3_dot_product(v1, v2); in _compute_ortho_norm()
H A Dcs_mesh_quantities.c512 if (cs_math_3_dot_product(vn[tri_id], f_norm) < 0.0) in _compute_face_quantities()
566 if (cs_math_3_dot_product(vn, f_norm) < 0.0) in _compute_face_quantities()
714 tri_vol_part += one_third * 0.5 * cs_math_3_dot_product(vtc, vn); in _adjust_face_cog_v11_v52()
718 if (cs_math_3_dot_product(vn, face_norm[f_id]) < 0.0) in _adjust_face_cog_v11_v52()
842 if (cs_math_3_dot_product(vn, face_norm[f_id]) < 0.0) in _refine_warped_face_centers()
1334 double ps = cs_math_3_dot_product(i_face_normal[face_id], in _recompute_cell_cen_face()
1356 double ps = cs_math_3_dot_product(b_face_normal[face_id], in _recompute_cell_cen_face()
/dports/science/code_saturne/code_saturne-7.1.0/src/base/
H A Dcs_post_util.c249 _s[i] = cs_math_3_dot_product(dx, dx1) / s_norm2; in cs_cell_segment_intersect_probes_define()
484 return cs_math_3_dot_product(moment, axis); in cs_post_moment_of_force()
568 + cs_math_3_dot_product(gradp[cell_id], in cs_post_b_pressure()
599 + cs_math_3_dot_product(gradk[cell_id], in cs_post_b_pressure()
946 + cs_math_3_dot_product(diipb[face_id], grad[cell_id]); in cs_post_field_cell_to_b_face_values()
H A Dcs_fan.c488 coo_axis = cs_math_3_dot_product(d_cel_axis, fan->axis_dir); in cs_fan_build_all()
682 if ( cs_math_3_dot_product(fan->axis_dir, i_face_normal[face_id]) in cs_fan_compute_flows()
705 if (cs_math_3_dot_product(fan->axis_dir, b_face_normal[face_id]) > 0.0) in cs_fan_compute_flows()
857 coo_axis = cs_math_3_dot_product(d_cel_axis, fan->axis_dir); in cs_fan_compute_force()
H A Dcs_ext_neighborhood.c1343 if (cs_math_3_dot_product(seg_0, seg_1) <= 0) in _neighborhood_reduce_cell_center_opposite()
1361 if (cs_math_3_dot_product(seg_0, seg_1) <= 0) in _neighborhood_reduce_cell_center_opposite()
1376 if (cs_math_3_dot_product(seg_0, n_c_s[j]) <= 0) in _neighborhood_reduce_cell_center_opposite()
1418 if (cs_math_3_dot_product(seg_0, seg_1) <= 0) in _neighborhood_reduce_cell_center_opposite()
1438 if (cs_math_3_dot_product(seg_0, seg_1) <= 0) in _neighborhood_reduce_cell_center_opposite()
1453 if (cs_math_3_dot_product(seg_0, n_c_s[j]) <= 0) in _neighborhood_reduce_cell_center_opposite()
H A Dcs_ale.c230 cs_real_t dz_fn = cs_math_3_dot_product(normal, v_cog); in _free_surface()
271 (cs_math_3_dot_product(normal, b_face_normal[face_id]) in _free_surface()
305 cs_real_t dz = CS_ABS(cs_math_3_dot_product(normal, e_cog)); in _free_surface()
356 cs_real_t dz_fn = cs_math_3_dot_product(normal, v1_cog); in _free_surface()
974 cs_real_t prosrf = cs_math_3_dot_product(grav, b_face_normal[face_id]); in _ale_solve_poisson_legacy()
H A Dcs_pressure_correction.c606 = ( cs_math_3_dot_product(dist, visci[0]) * n[0] in cs_pressure_correction()
607 + cs_math_3_dot_product(dist, visci[1]) * n[1] in cs_pressure_correction()
608 + cs_math_3_dot_product(dist, visci[2]) * n[2]); in cs_pressure_correction()
635 cs_real_t bpmasf = cs_math_3_dot_product(vel[c_id], in cs_pressure_correction()
2259 = ( cs_math_3_dot_product(dist, visci[0]) * n[0] in cs_pressure_correction()
2260 + cs_math_3_dot_product(dist, visci[1]) * n[1] in cs_pressure_correction()
2261 + cs_math_3_dot_product(dist, visci[2]) * n[2]); in cs_pressure_correction()
H A Dcs_vof.c655 rhofac * cs_math_3_dot_product(i_f_face_normal[f_id], vr); in cs_vof_log_mass_budget()
670 bpro_rom[f_id] * cs_math_3_dot_product(b_f_face_normal[f_id], vr); in cs_vof_log_mass_budget()
H A Dcs_porosity_from_scan.c724 i_massflux[face_id] = cs_math_3_dot_product(normal, in cs_compute_porosity_from_scan()
738 b_massflux[face_id] = cs_math_3_dot_product(normal, in cs_compute_porosity_from_scan()
/dports/science/code_saturne/code_saturne-7.1.0/src/atmo/
H A Dcs_atprke.c301 cs_math_3_dot_product(grad[c_id], grav) / prdtur; in _dry_atmosphere()
454 * (cs_math_3_dot_product(grad[c_id], grav) in _humid_atmosphere()
481 * (cs_math_3_dot_product(grad[c_id], grav) in _humid_atmosphere()
/dports/science/code_saturne/code_saturne-7.1.0/src/lagr/
H A Dcs_lagr_tracking.c1583 tmp = 2. * cs_math_3_dot_product(disp, face_norm); in _boundary_treatment()
1590 tmp = 2. * cs_math_3_dot_product(particle_velocity, face_norm); in _boundary_treatment()
1595 tmp = 2. * cs_math_3_dot_product(particle_velocity_seen, face_norm); in _boundary_treatment()
1623 tmp = 2. * cs_math_3_dot_product(disp, face_norm); in _boundary_treatment()
1630 tmp = 2. * cs_math_3_dot_product(particle_velocity, face_norm); in _boundary_treatment()
1635 tmp = 2. * cs_math_3_dot_product(particle_velocity_seen, face_norm); in _boundary_treatment()
1673 tmp = 2. * cs_math_3_dot_product(disp, face_norm); in _boundary_treatment()
1680 tmp = 2. * cs_math_3_dot_product(particle_velocity, face_norm); in _boundary_treatment()
1685 tmp = 2. * cs_math_3_dot_product(particle_velocity_seen, face_norm); in _boundary_treatment()
1779 tmp = 2. * cs_math_3_dot_product(disp, face_norm); in _boundary_treatment()
[all …]
H A Dcs_lagr_head_losses.c228 cs_real_t prod1 = cs_math_3_dot_product(q[iel1], i_face_normal[ifac]); in _porcel()
229 cs_real_t prod2 =-cs_math_3_dot_product(q[iel2], i_face_normal[ifac]); in _porcel()
H A Dcs_lagr_resuspension.c250 * cs_math_3_dot_product(gravity, i_face_normal[face_id]); in cs_lagr_resuspension()
311 * cs_math_3_dot_product(part_vel, part_vel); in cs_lagr_resuspension()
/dports/science/code_saturne/code_saturne-7.1.0/src/alge/
H A Dcs_face_viscosity.c686 cs_real_t fikis = cs_math_3_dot_product(fiki, i_face_normal[face_id]); in cs_face_anisotropic_viscosity_scalar()
710 cs_real_t fjkjs = cs_math_3_dot_product(fjkj, i_face_normal[face_id]); in cs_face_anisotropic_viscosity_scalar()
752 cs_real_t fikis = cs_math_3_dot_product(fiki, b_face_normal[face_id]); in cs_face_anisotropic_viscosity_scalar()
H A Dcs_convection_diffusion.h454 cs_real_t dotp = CS_ABS(cs_math_3_dot_product(gradv_c, i_face_normal)); in cs_nvd_vof_scheme_scalar()
798 *recoi = bldfrp*(cs_math_3_dot_product(gradpf, diipf)); in cs_i_compute_quantities()
799 *recoj = bldfrp*(cs_math_3_dot_product(gradpf, djjpf)); in cs_i_compute_quantities()
847 recoi[isou] = bldfrp*(cs_math_3_dot_product(dpvf, diipf)); in cs_i_compute_quantities_vector()
848 recoj[isou] = bldfrp*(cs_math_3_dot_product(dpvf, djjpf)); in cs_i_compute_quantities_vector()
899 recoi[isou] = bldfrp*(cs_math_3_dot_product(dpvf, diipf)); in cs_i_compute_quantities_tensor()
900 recoj[isou] = bldfrp*(cs_math_3_dot_product(dpvf, djjpf)); in cs_i_compute_quantities_tensor()
1163 *pf = p + cs_math_3_dot_product(df, grad); in cs_solu_f_val()
3820 const cs_real_t gradc = cs_math_3_dot_product(gradv_c, ndc); in cs_i_cd_unsteady_nvd()
/dports/science/code_saturne/code_saturne-7.1.0/src/rayt/
H A Dcs_rad_transfer_dir.c150 a = acos(cs_math_3_dot_product(posnod[0], posnod[1])); in _lhuilier()
151 b = acos(cs_math_3_dot_product(posnod[1], posnod[2])); in _lhuilier()
152 c = acos(cs_math_3_dot_product(posnod[2], posnod[0])); in _lhuilier()
H A Dcs_rad_transfer_solve.c545 aa = cs_math_3_dot_product(vect_s, b_face_normal[face_id]); in _cs_rad_transfer_sol()
649 if (cs_math_3_dot_product(grav, vect_s) < 0.0) in _cs_rad_transfer_sol()
699 flurds[face_id] = cs_math_3_dot_product(vect_s, in _cs_rad_transfer_sol()
704 flurdb[face_id] = cs_math_3_dot_product(vect_s, in _cs_rad_transfer_sol()
786 aa = cs_math_3_dot_product(vect_s, b_face_normal[face_id]); in _cs_rad_transfer_sol()
794 if (cs_math_3_dot_product(cs_glob_physical_constants->gravity, in _cs_rad_transfer_sol()
800 else if (cs_math_3_dot_product(cs_glob_physical_constants->gravity, in _cs_rad_transfer_sol()
/dports/science/code_saturne/code_saturne-7.1.0/src/user_examples/
H A Dcs_user_parameters-time_moments.c187 cs_real_t xr = cs_math_3_dot_product(cell_cen[i], e_r); in _velocity_moment_data()
/dports/science/code_saturne/code_saturne-7.1.0/src/turb/
H A Dcs_les_inflow.c356 = cs_math_3_dot_product(mod_wave_vector, spectral_coordinates) in _batten_method()
407 cs_real_t dot_product = cs_math_3_dot_product(fluct, normal); in _rescale_flowrate()
455 cs_real_t normal_comp = cs_math_3_dot_product(fluct, normal_unit); in _rescale_flowrate()
456 cs_real_t tangent_comp1 = cs_math_3_dot_product(fluct, tangent_unit1); in _rescale_flowrate()
457 cs_real_t tangent_comp2 = cs_math_3_dot_product(fluct, tangent_unit2); in _rescale_flowrate()
H A Dcs_turbulence_rotation.c340 dsijdt += cs_math_3_dot_product(vela[c_id], in cs_turbulence_rotation_correction()
/dports/science/code_saturne/code_saturne-7.1.0/src/cfbl/
H A Dcs_cf_thermo.c977 cs_real_t uni = cs_math_3_dot_product(vel[cell_id],b_face_normal[face_id]) in cs_cf_thermo_wall_bc()
1091 uni = cs_math_3_dot_product(vel[cell_id],b_face_normal[face_id]) in cs_cf_thermo_subsonic_outlet_bc()
1356 cosalp = cs_math_3_dot_product(dir,b_face_normal[face_id]) in cs_cf_thermo_ph_inlet_bc()
1372 uni = cs_math_3_dot_product(vel[cell_id],b_face_normal[face_id]) in cs_cf_thermo_ph_inlet_bc()
1570 bMach = cs_math_3_dot_product(bc_vel[face_id],b_face_normal[face_id]) in cs_cf_thermo_ph_inlet_bc()
/dports/science/code_saturne/code_saturne-7.1.0/src/cdo/
H A Dcs_cdofb_navsto.c102 #define _dp3 cs_math_3_dot_product
477 mass_flux[f_id] = rho_val*cs_math_3_dot_product(face_vel + 3*f_id, fq); in cs_cdofb_navsto_mass_flux()
513 div += c2f->sgn[f]*cs_math_3_dot_product(_val, fnorm); in cs_cdofb_navsto_cell_divergence()
1311 double hc = cs_math_3_dot_product(u_cell + 3*c_id, w); in cs_cdofb_navsto_extra_op()
1345 double hc = cs_math_3_dot_product(u_cell + 3*c_id, w); in cs_cdofb_navsto_extra_op()
H A Dcs_walldistance.c77 #define _dp3 cs_math_3_dot_product
/dports/science/code_saturne/code_saturne-7.1.0/tests/
H A Dcs_check_sdm.c47 #define _dp3 cs_math_3_dot_product

1234