/dports/science/code_saturne/code_saturne-7.1.0/src/user_examples/ |
H A D | cs_user_extra_operations-vorticity_field.c | 139 cs_field_t *vort = cs_field_by_name_try("vorticity"); in cs_user_extra_operations() local 143 if (vort != NULL) { in cs_user_extra_operations() 145 vort->val[i] = gradv[i][1][0] - gradv[i][0][1]; in cs_user_extra_operations()
|
/dports/science/code_saturne/code_saturne-7.1.0/src/turb/ |
H A D | cs_turbulence_sa.c | 118 _vort_trace(cs_real_t vort[], in _vort_trace() argument 137 vort[i] = cs_math_pow2(grad_vel[i][0][1] - grad_vel[i][1][0]) in _vort_trace() 182 const cs_real_t vort[], in _src_terms() argument 289 const cs_real_t omega = sqrt(vort[i]); in _src_terms() 463 cs_real_t *vort; /* vorticity omega*/ in cs_turbulence_sa() local 469 BFT_MALLOC(vort, n_cells_ext, cs_real_t); in cs_turbulence_sa() 478 _vort_trace(vort, tr_gr_u, tr_gr_nu); in cs_turbulence_sa() 488 vort, in cs_turbulence_sa() 494 BFT_FREE(vort); in cs_turbulence_sa()
|
/dports/graphics/blender/blender-2.91.0/extern/mantaflow/preprocessed/plugin/ |
H A D | vortexplugins.cpp | 327 vector<Vec3> vort(mesh.numTris()), pos(mesh.numTris()); in smoothVorticity() local 352 vort[i] = mesh.sheet(i).vorticitySmoothed; in smoothVorticity() 357 Vec3 v = vort[i]; in smoothVorticity() 360 v += w * vort[index[idx]]; in smoothVorticity() 488 Grid<Vec3> &vort = (vorticity) ? (*vorticity) : (vortTemp); in VICintegration() local 489 vort.clear(); in VICintegration() 503 if (pos.x + i < 0 || (int)pos.x + i >= vort.getSizeX()) in VICintegration() 506 if (pos.y + j < 0 || (int)pos.y + j >= vort.getSizeY()) in VICintegration() 527 if (pos.x + i < 0 || (int)pos.x + i >= vort.getSizeX()) in VICintegration() 544 vort(cell) += v * w; in VICintegration() [all …]
|
/dports/math/vtk6/VTK-6.2.0/Filters/FlowPaths/ |
H A D | vtkStreamer.cxx | 244 double tOffset, vort[3]; in ThreadedIntegrate() local 406 vort[0] = derivs[7] - derivs[5]; in ThreadedIntegrate() 407 vort[1] = derivs[2] - derivs[6]; in ThreadedIntegrate() 408 vort[2] = derivs[3] - derivs[1]; in ThreadedIntegrate() 410 pt2.omega = vtkMath::Dot(vort, pt2.v); in ThreadedIntegrate() 480 double v[3], *cellVel, derivs[9], xNext[3], vort[3]; in Integrate() local 604 vort[0] = derivs[7] - derivs[5]; in Integrate() 605 vort[1] = derivs[2] - derivs[6]; in Integrate() 606 vort[2] = derivs[3] - derivs[1]; in Integrate() 608 sPtr->omega = vtkMath::Dot(vort, sPtr->v); in Integrate()
|
H A D | vtkStreamTracer.cxx | 791 double point1[3], point2[3], pcoords[3], vort[3], omega; in Integrate() local 866 vort[0] = 0; in Integrate() 867 vort[1] = 0; in Integrate() 868 vort[2] = 0; in Integrate() 870 vorticity->InsertNextTuple(vort); in Integrate() 875 omega = vtkMath::Dot(vort, velocity); in Integrate() 1015 vort[0] = 0; in Integrate() 1016 vort[1] = 0; in Integrate() 1017 vort[2] = 0; in Integrate() 1019 vorticity->InsertNextTuple(vort); in Integrate() [all …]
|
/dports/math/vtk8/VTK-8.2.0/Filters/FlowPaths/ |
H A D | vtkStreamTracer.cxx | 808 double point1[3], point2[3], pcoords[3], vort[3], omega; in Integrate() local 888 vort[0] = 0; in Integrate() 889 vort[1] = 0; in Integrate() 890 vort[2] = 0; in Integrate() 892 vorticity->InsertNextTuple(vort); in Integrate() 897 omega = vtkMath::Dot(vort, velocity); in Integrate() 1078 vort[0] = 0; in Integrate() 1079 vort[1] = 0; in Integrate() 1080 vort[2] = 0; in Integrate() 1082 vorticity->InsertNextTuple(vort); in Integrate() [all …]
|
/dports/math/vtk9/VTK-9.1.0/Filters/FlowPaths/ |
H A D | vtkStreamTracer.cxx | 797 double point1[3], point2[3], pcoords[3], vort[3], omega; in Integrate() local 876 vort[0] = 0; in Integrate() 877 vort[1] = 0; in Integrate() 878 vort[2] = 0; in Integrate() 880 vorticity->InsertNextTuple(vort); in Integrate() 885 omega = vtkMath::Dot(vort, velocity); in Integrate() 1064 vort[0] = 0; in Integrate() 1065 vort[1] = 0; in Integrate() 1066 vort[2] = 0; in Integrate() 1068 vorticity->InsertNextTuple(vort); in Integrate() [all …]
|
/dports/math/vtk9/VTK-9.1.0/Filters/General/ |
H A D | vtkCellDerivatives.cxx | 76 vtkDoubleArray* vort, vtkDoubleArray* t, int tMode, int csd, int cvd, int cv) in CellDerivatives() 81 , OutVorticity(vort) in CellDerivatives() 216 vtkDoubleArray* g, vtkDoubleArray* vort, vtkDoubleArray* t, int tMode, int csd, int cvd, int cv) in operator ()() 218 CellDerivatives<ScalarsT, VectorsT> cd(input, s, v, g, vort, t, tMode, csd, cvd, cv); in operator ()()
|
/dports/cad/calculix-ccx/CalculiX/ccx_2.18/src/ |
H A D | calcstressheatfluxfem.f | 39 & tt(3,3),rho,t(3,3),vkl(3,3),xkin,unt,umt,f2,a1,vort,xtuf, 200 vort=dsqrt((vkl(3,2)-vkl(2,3))**2+ 205 unt=a1*xkin/max(a1*xtuf,vort*f2)
|
/dports/math/vtk8/VTK-8.2.0/IO/MPIParallel/ |
H A D | vtkPWindBladeReader.cxx | 165 void vtkPWindBladeReader::CalculateVorticity(int vort, int uvw, int density) in CalculateVorticity() argument 168 return this->Superclass::CalculateVorticity(vort, uvw, density); in CalculateVorticity() 171 this->Data[vort]->SetNumberOfComponents(1); in CalculateVorticity() 172 this->Data[vort]->SetNumberOfTuples(this->NumberOfTuples); in CalculateVorticity() 173 float* vortData = this->Data[vort]->GetPointer(0); in CalculateVorticity()
|
H A D | vtkPWindBladeReader.h | 56 virtual void CalculateVorticity(int vort, int uvw, int density) override;
|
/dports/math/vtk9/VTK-9.1.0/IO/MPIParallel/ |
H A D | vtkPWindBladeReader.cxx | 167 void vtkPWindBladeReader::CalculateVorticity(int vort, int uvw, int density) in CalculateVorticity() argument 170 return this->Superclass::CalculateVorticity(vort, uvw, density); in CalculateVorticity() 173 this->Data[vort]->SetNumberOfComponents(1); in CalculateVorticity() 174 this->Data[vort]->SetNumberOfTuples(this->NumberOfTuples); in CalculateVorticity() 175 float* vortData = this->Data[vort]->GetPointer(0); in CalculateVorticity()
|
H A D | vtkPWindBladeReader.h | 54 void CalculateVorticity(int vort, int uvw, int density) override;
|
/dports/math/vtk6/VTK-6.2.0/IO/MPIParallel/ |
H A D | vtkPWindBladeReader.cxx | 165 void vtkPWindBladeReader::CalculateVorticity(int vort, int uvw, int density) in CalculateVorticity() argument 168 return this->Superclass::CalculateVorticity(vort, uvw, density); in CalculateVorticity() 171 this->Data[vort]->SetNumberOfComponents(1); in CalculateVorticity() 172 this->Data[vort]->SetNumberOfTuples(this->NumberOfTuples); in CalculateVorticity() 173 float* vortData = this->Data[vort]->GetPointer(0); in CalculateVorticity()
|
H A D | vtkPWindBladeReader.h | 54 virtual void CalculateVorticity(int vort, int uvw, int density);
|
/dports/math/vtk8/VTK-8.2.0/Filters/Generic/ |
H A D | vtkGenericStreamTracer.cxx | 848 double point1[3], point2[3], pcoords[3], vort[3], omega; in Integrate() local 928 vort); in Integrate() 930 vorticity->InsertNextTuple(vort); in Integrate() 935 omega = vtkMath::Dot(vort, velocity); in Integrate() 1073 vort); in Integrate() 1075 vorticity->InsertNextTuple(vort); in Integrate() 1079 omega = vtkMath::Dot(vort, velocity); in Integrate()
|
/dports/math/vtk9/VTK-9.1.0/Filters/Generic/ |
H A D | vtkGenericStreamTracer.cxx | 804 double point1[3], point2[3], pcoords[3], vort[3], omega; in Integrate() local 881 vtkGenericStreamTracer::CalculateVorticity(cell, pcoords, inVectors, vort); in Integrate() 883 vorticity->InsertNextTuple(vort); in Integrate() 888 omega = vtkMath::Dot(vort, velocity); in Integrate() 1016 vtkGenericStreamTracer::CalculateVorticity(cell, pcoords, inVectors, vort); in Integrate() 1018 vorticity->InsertNextTuple(vort); in Integrate() 1022 omega = vtkMath::Dot(vort, velocity); in Integrate()
|
/dports/math/vtk6/VTK-6.2.0/Filters/Generic/ |
H A D | vtkGenericStreamTracer.cxx | 849 double point1[3], point2[3], pcoords[3], vort[3], omega; in Integrate() local 929 vort); in Integrate() 931 vorticity->InsertNextTuple(vort); in Integrate() 936 omega = vtkMath::Dot(vort, velocity); in Integrate() 1074 vort); in Integrate() 1076 vorticity->InsertNextTuple(vort); in Integrate() 1080 omega = vtkMath::Dot(vort, velocity); in Integrate()
|
/dports/math/vtk6/VTK-6.2.0/IO/Geometry/ |
H A D | vtkMultiBlockPLOT3DReader.cxx | 1767 double d, rr, *m, u, v, w, v2, *vort, s; in ComputeSwirl() local 1798 vort = vorticity->GetTuple(i); in ComputeSwirl() 1806 s = (vort[0]*m[0] + vort[1]*m[1] + vort[2]*m[2]) / v2; in ComputeSwirl() 1873 double vort[3], xp[3], xm[3], vp[3], vm[3], factor; in ComputeVorticity() local 2084 vort[0]= xiy*wxi+etay*weta+zetay*wzeta - xiz*vxi-etaz*veta-zetaz*vzeta; in ComputeVorticity() 2085 vort[1]= xiz*uxi+etaz*ueta+zetaz*uzeta - xix*wxi-etax*weta-zetax*wzeta; in ComputeVorticity() 2086 vort[2]= xix*vxi+etax*veta+zetax*vzeta - xiy*uxi-etay*ueta-zetay*uzeta; in ComputeVorticity() 2088 vorticity->SetTuple(idx,vort); in ComputeVorticity() 2500 double* vort = vorticity->GetTuple(idx); in ComputeVorticityMagnitude() local 2501 double magnitude = sqrt(vort[0]*vort[0]+ in ComputeVorticityMagnitude() [all …]
|
/dports/math/libpgmath/flang-d07daf3/test/ncar_kernels/HOMME_vlaplace_sphere_wk/src/ |
H A D | derivative_mod.F90 | 511 FUNCTION vorticity_sphere(v, deriv, elem) RESULT ( vort ) 519 REAL(KIND=real_kind) :: vort(np,np) local 542 vort(l ,j) = dvdx00 548 vort(i,j) = (vort(i,j)-vtemp(i,j))*(elem%rmetdet(i,j)*rrearth)
|
/dports/science/dakota/dakota-6.13.0-release-public.src-UI/packages/external/trilinos/packages/rol/example/PDE-OPT/dynamic/navier-stokes/ |
H A D | flowMovie.m | 13 elseif (strcmp(type,'vort'))
|
/dports/math/vtk8/VTK-8.2.0/IO/Parallel/ |
H A D | vtkMultiBlockPLOT3DReader.cxx | 446 double d, rr, u, v, w, v2, s, m[3], vort[3]; in operator ()() local 453 Vorticity->GetTuple(i, vort); in operator ()() 461 s = (vort[0]*m[0] + vort[1]*m[1] + vort[2]*m[2]) / v2; in operator ()() 512 double vort[3]; in operator ()() local 515 Vorticity->GetTuple(i, vort); in operator ()() 516 double magnitude = sqrt(vort[0]*vort[0]+ in operator ()() 517 vort[1]*vort[1]+vort[2]*vort[2]); in operator ()() 747 double vort[3], xp[3], xm[3], vp[3], vm[3], factor; in operator ()() local 941 vort[0]= xiy*wxi+etay*weta+zetay*wzeta - xiz*vxi-etaz*veta-zetaz*vzeta; in operator ()() 942 vort[1]= xiz*uxi+etaz*ueta+zetaz*uzeta - xix*wxi-etax*weta-zetax*wzeta; in operator ()() [all …]
|
/dports/math/vtk9/VTK-9.1.0/IO/Parallel/ |
H A D | vtkMultiBlockPLOT3DReader.cxx | 493 double d, rr, u, v, w, v2, s, m[3], vort[3]; in operator ()() local 500 Vorticity->GetTuple(i, vort); in operator ()() 508 s = (vort[0] * m[0] + vort[1] * m[1] + vort[2] * m[2]) / v2; in operator ()() 566 double vort[3]; in operator ()() local 569 Vorticity->GetTuple(i, vort); in operator ()() 570 double magnitude = sqrt(vort[0] * vort[0] + vort[1] * vort[1] + vort[2] * vort[2]); in operator ()() 807 double vort[3], xp[3], xm[3], vp[3], vm[3], factor; in operator ()() local 1000 vort[0] = xiy * wxi + etay * weta + zetay * wzeta - xiz * vxi - etaz * veta - zetaz * vzeta; in operator ()() 1001 vort[1] = xiz * uxi + etaz * ueta + zetaz * uzeta - xix * wxi - etax * weta - zetax * wzeta; in operator ()() 1002 vort[2] = xix * vxi + etax * veta + zetax * vzeta - xiy * uxi - etay * ueta - zetay * uzeta; in operator ()() [all …]
|
/dports/astro/py-metpy/MetPy-1.1.0/tests/calc/ |
H A D | test_kinematics.py | 71 vort = vorticity(u, v, dx=1 * units.meters, dy=2 * units.meters) 73 assert_array_equal(vort, true_vort) 508 vort = absolute_vorticity(u, v, 1 * units.meters, 2 * units.meters, lats) 512 assert_almost_equal(vort, true_vort, 5) 1127 vort = vorticity(data_4d.u, data_4d.v) 1165 assert_array_almost_equal(vort.data, truth, 12)
|
/dports/science/cdo/cdo-2.0.0/src/ |
H A D | NCL_wind.cc | 51 double *vort) in uv2vr_cfd_W() argument 67 double *tmp_vort = vort + k * gridsize_uv; in uv2vr_cfd_W()
|