Rocstar  1.0
Rocstar multiphysics simulation application
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
read.cpp File Reference
#include <cstring>
#include <cstdio>
#include <strings.h>
#include "gridutil.h"
#include "util.h"
#include "FC.h"
Include dependency graph for read.cpp:

Go to the source code of this file.

Typedefs

typedef double REAL
 

Functions

void FC_GLOBAL (accept_locations, ACCEPT_LOCATIONS)(int *ni
 
 for (i[0]=0;i[0]< dim[0];i[0]++)
 
curConsumer consume (dim, v)
 
curConsumer freeBlock (v)
 
void FC_GLOBAL (read_msh, READ_MSH)(const char *fName)
 
const char * read_grd (const char *gridFile, blockConsumer &dest)
 
const char * read_grds (const char *gridFile, blockConsumer &dest)
 
const char * read_grdd (const char *gridFile, blockConsumer &dest)
 
const char * read_reg (const char *regFile, blockConsumer &dest)
 
const char * read_hdf (const char *hdfName, blockConsumer &dest)
 
const char * read_file (const char *file, blockConsumer &dest)
 
const char * read_multiple (const char *file, blockConsumer &dest)
 

Variables

static blockConsumercurConsumer =NULL
 
void int * nj
 
void int int * nk
 
void int int REALx
 
void int int REAL REALy
 
void int int REAL REAL REAL *z
blockDim dim * 
ni
 
vector3dv =curConsumer->allocateBlock(dim)
 
blockLoc i
 

Typedef Documentation

typedef double REAL

Definition at line 70 of file read.cpp.

Function Documentation

curConsumer consume ( dim  ,
v   
)
void FC_GLOBAL ( accept_locations  ,
ACCEPT_LOCATIONS   
)
void FC_GLOBAL ( read_msh  ,
READ_MSH   
) const
for ( )

Definition at line 82 of file read.cpp.

References i, x, vector3d::x, y, vector3d::y, z, and vector3d::z.

83  { //Copy data from Fortran array
84  int c_i=dim[i], f_i=dim[i];
85  v[c_i].x=x[f_i];
86  v[c_i].y=y[f_i];
87  v[c_i].z=z[f_i];
88  }
void int int REAL REAL * y
Definition: read.cpp:74
*********************************************************************Illinois Open Source License ****University of Illinois NCSA **Open Source License University of Illinois All rights reserved ****Developed free of to any person **obtaining a copy of this software and associated documentation to deal with the Software without including without limitation the rights to and or **sell copies of the and to permit persons to whom the **Software is furnished to do subject to the following this list of conditions and the following disclaimers ****Redistributions in binary form must reproduce the above **copyright this list of conditions and the following **disclaimers in the documentation and or other materials **provided with the distribution ****Neither the names of the Center for Simulation of Advanced the University of nor the names of its **contributors may be used to endorse or promote products derived **from this Software without specific prior written permission ****THE SOFTWARE IS PROVIDED AS WITHOUT WARRANTY OF ANY **EXPRESS OR INCLUDING BUT NOT LIMITED TO THE WARRANTIES **OF FITNESS FOR A PARTICULAR PURPOSE AND **NONINFRINGEMENT IN NO EVENT SHALL THE CONTRIBUTORS OR **COPYRIGHT HOLDERS BE LIABLE FOR ANY DAMAGES OR OTHER WHETHER IN AN ACTION OF TORT OR **ARISING OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE **USE OR OTHER DEALINGS WITH THE SOFTWARE v
Definition: roccomf90.h:20
void int int int REAL REAL REAL * z
Definition: write.cpp:76
blockLoc i
Definition: read.cpp:79
void int int REAL * x
Definition: read.cpp:74
curConsumer freeBlock ( v  )
const char* read_file ( const char *  file,
blockConsumer dest 
)

Definition at line 102 of file read.cpp.

References endsWith(), FC_GLOBAL, fortranifyString(), read_grd(), read_grdd(), read_grds(), read_hdf(), read_msh(), and read_reg().

103 {
104  curConsumer=&dest;
105  if (endsWith(file,".msh"))
106  FC_GLOBAL(read_msh,READ_MSH)(fortranifyString(file));
107  else if (endsWith(file,".grd"))
108  return read_grd(file,dest);
109  else if (endsWith(file,".grds"))
110  return read_grds(file,dest);
111  else if (endsWith(file,".grdd"))
112  return read_grdd(file,dest);
113 #ifdef USE_HDF
114  else if (endsWith(file,".hdf"))
115  return read_hdf(file,dest);
116 #endif
117  else if (endsWith(file,".reg"))
118  return read_reg(file,dest);
119  else
120  return "Unrecognized input mesh file extension! ("__FILE__")";
121  return NULL;
122 }
const char * read_hdf(const char *hdfName, blockConsumer &dest)
Definition: readhdf.cpp:76
bool endsWith(const char *a, const char *suffix)
const char * read_reg(const char *regFile, blockConsumer &dest)
Definition: readreg.cpp:63
const char * read_grds(const char *gridFile, blockConsumer &dest)
Definition: readgrd.cpp:201
const char * read_grdd(const char *gridFile, blockConsumer &dest)
Definition: readgrd.cpp:206
#define FC_GLOBAL(name, NAME)
Definition: FC.h:5
subroutine read_msh(F_name)
Definition: readmsh.f90:57
const char * read_grd(const char *gridFile, blockConsumer &dest)
Definition: readgrd.cpp:196
const char * fortranifyString(const char *src)
static blockConsumer * curConsumer
Definition: read.cpp:67

Here is the call graph for this function:

const char* read_grd ( const char *  gridFile,
blockConsumer dest 
)

Definition at line 196 of file readgrd.cpp.

References read_general().

Referenced by read_file().

197 {
199  return read_general(gridFile,fmt,dest);
200 }
ASCII format input file:
Definition: readgrd.cpp:115
const char * read_general(const char *gridFile, gridgenGrdFormatter &fmt, blockConsumer &dest)
Definition: readgrd.cpp:152

Here is the call graph for this function:

Here is the caller graph for this function:

const char* read_grdd ( const char *  gridFile,
blockConsumer dest 
)

Definition at line 206 of file readgrd.cpp.

References read_general().

Referenced by read_file().

207 {
209  return read_general(gridFile,fmt,dest);
210 }
const char * read_general(const char *gridFile, gridgenGrdFormatter &fmt, blockConsumer &dest)
Definition: readgrd.cpp:152

Here is the call graph for this function:

Here is the caller graph for this function:

const char* read_grds ( const char *  gridFile,
blockConsumer dest 
)

Definition at line 201 of file readgrd.cpp.

References read_general().

Referenced by read_file().

202 {
204  return read_general(gridFile,fmt,dest);
205 }
const char * read_general(const char *gridFile, gridgenGrdFormatter &fmt, blockConsumer &dest)
Definition: readgrd.cpp:152

Here is the call graph for this function:

Here is the caller graph for this function:

const char* read_hdf ( const char *  hdfName,
blockConsumer dest 
)

Definition at line 76 of file readhdf.cpp.

References blockConsumer::allocateBlock(), chk, blockConsumer::consume(), coord, d, blockConsumer::freeBlock(), blockDim::getSize(), i, and rank.

Referenced by read_file().

77 {
78  int32 i, d;
79  //Open the input file
80  int32 sd_id = SDstart(filename, DFACC_READ);
81  if (sd_id==-1) return "Couldn't open HDF input file!";
82 
83  //Select the X, Y, and Z components
84  int32 sds_id[3];
85  for (i=0;i<3;i++) sds_id[i]=chk(SDselect(sd_id,5+4*i));
86 
87  //Determine the ni, nj, and nk dimensions
88  blockDim dim;
89  /* This doesn't work.
90  for (d=0;d<3;d++) {
91  int32 dim_id = chk(SDgetdimid(sds_id[0],d));
92  char dim_name[200];
93  int32 dim_size, data_type, n_attrs;
94  chk(SDdiminfo(dim_id, dim_name, &dim_size, &data_type, &n_attrs));
95  dim[2-d]=dim_size;
96  }
97  */
98  char name[200];
99  int32 rank, size[3], data_type, n_attrs;
100  chk(SDgetinfo(sds_id[0], name, &rank, size, &data_type, &n_attrs));
101  dim[0]=size[2];
102  dim[1]=size[1];
103  dim[2]=size[0];
104 
105  //Allocate storage for the X, Y, and Z output
106  vector3d *locs=dest.allocateBlock(dim);
107 
108  //Read each of X, Y, and Z
109  int nLocs=dim.getSize();
110  double *coord=new double[nLocs];
111  for (i=0;i<3;i++)
112  {
113  int32 start[3]={0,0,0};
114  int32 edges[3];
115  for (d=0;d<3;d++) edges[d]=dim[2-d];
116  chk(SDreaddata(sds_id[i], start, NULL, edges, coord));
117  //Copy this coordinate into locs
118  for (int l=0;l<nLocs;l++) locs[l][i]=coord[l];
119  }
120  delete[] coord;
121 
122  //Pass locations to consumer
123  dest.consume(dim,locs);
124  dest.freeBlock(locs);
125 
126  //Close the file and return
127  for (i=0;i<3;i++) chk(SDendaccess(sds_id[i]));
128  chk(SDend(sd_id));
129  return NULL;
130 }
const NT & d
int coord[NPANE][NROW *NCOL][3]
Definition: blastest.C:86
#define chk(x)
Definition: readhdf.cpp:66
virtual vector3d * allocateBlock(blockDim &dim)
Definition: read.cpp:146
virtual void freeBlock(vector3d *blk)
Definition: read.cpp:150
blockLoc i
Definition: read.cpp:79
static int rank
Definition: advectest.C:66
int getSize(void) const
Definition: gridutil.h:126
virtual const char * consume(const blockDim &dim, vector3d *locs)=0

Here is the call graph for this function:

Here is the caller graph for this function:

const char* read_multiple ( const char *  file,
blockConsumer dest 
)

Definition at line 126 of file read.cpp.

References fileExists(), incrementAscii(), and read_file().

Referenced by blockConsumer::read().

127 {
128  char tmp[1024];
129  strcpy(tmp,file);
130  do {
131  printf("Reading block file '%s'...\n",tmp);
132  const char *ret=read_file(tmp,dest);
133  if (ret!=NULL) return ret;
134  if (!incrementAscii(tmp)) return NULL;
135  } while (fileExists(tmp));
136  return NULL;
137 }
bool fileExists(const char *fName)
bool incrementAscii(char *cur)
void read_file(const char *fname, const string &wname, double alpha)
Definition: autosurfer.C:39

Here is the call graph for this function:

Here is the caller graph for this function:

const char* read_reg ( const char *  regFile,
blockConsumer dest 
)

Definition at line 63 of file readreg.cpp.

References blockConsumer::allocateBlock(), BLOCKSPAN_FOR, blockConsumer::consume(), cimg_library::cimg::fclose(), cimg_library::cimg::fopen(), blockConsumer::freeBlock(), i, max(), min(), s, and v.

Referenced by read_file().

64 {
65  //Open the input file
66  FILE *in=fopen(regFile,"r");
67  if (in==NULL) return "Couldn't open input .reg file";
68 
69  //Read the block size
70  int dimArr[3];
72  for (int axis=0;axis<3;axis++)
73  {
74  double m;
75  if (1!=fscanf(in,"%d",&dimArr[axis]))
76  return "Couldn't read block dimension";
77  if (1!=fscanf(in,"%lf",&m)) return "Couldn't read block min";
78  min[axis]=m;
79  if (1!=fscanf(in,"%lf",&m)) return "Couldn't read block max";
80  max[axis]=m;
81  }
82  fclose(in);
83 
84  //Allocate return grid
85  blockDim dim(dimArr[0],dimArr[1],dimArr[2]);
86  vector3d *locs=dest.allocateBlock(dim);
87 
88  //Fill in the grid
89  blockLoc i;
90  blockSpan s(blockLoc(0,0,0),dim);
91  BLOCKSPAN_FOR(i,s) {
92  vector3d v;
93  for (int axis=0;axis<3;axis++) {
94  double scl=i[axis]/(float)(dim[axis]-1);
95  v[axis]=min[axis]+scl*(max[axis]-min[axis]);
96  }
97  locs[dim[i]]=v;
98  }
99 
100  dest.consume(dim,locs);
101  dest.freeBlock(locs);
102 
103  return NULL; //Everything worked
104 }
double s
Definition: blastest.C:80
Vector_n max(const Array_n_const &v1, const Array_n_const &v2)
Definition: Vector_n.h:354
int fclose(std::FILE *file)
Close a file, and check for possible errors.
Definition: CImg.h:5507
*********************************************************************Illinois Open Source License ****University of Illinois NCSA **Open Source License University of Illinois All rights reserved ****Developed free of to any person **obtaining a copy of this software and associated documentation to deal with the Software without including without limitation the rights to and or **sell copies of the and to permit persons to whom the **Software is furnished to do subject to the following this list of conditions and the following disclaimers ****Redistributions in binary form must reproduce the above **copyright this list of conditions and the following **disclaimers in the documentation and or other materials **provided with the distribution ****Neither the names of the Center for Simulation of Advanced the University of nor the names of its **contributors may be used to endorse or promote products derived **from this Software without specific prior written permission ****THE SOFTWARE IS PROVIDED AS WITHOUT WARRANTY OF ANY **EXPRESS OR INCLUDING BUT NOT LIMITED TO THE WARRANTIES **OF FITNESS FOR A PARTICULAR PURPOSE AND **NONINFRINGEMENT IN NO EVENT SHALL THE CONTRIBUTORS OR **COPYRIGHT HOLDERS BE LIABLE FOR ANY DAMAGES OR OTHER WHETHER IN AN ACTION OF TORT OR **ARISING OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE **USE OR OTHER DEALINGS WITH THE SOFTWARE v
Definition: roccomf90.h:20
virtual vector3d * allocateBlock(blockDim &dim)
Definition: read.cpp:146
#define BLOCKSPAN_FOR(i, span)
Definition: gridutil.h:230
virtual void freeBlock(vector3d *blk)
Definition: read.cpp:150
blockLoc i
Definition: read.cpp:79
Vector_n min(const Array_n_const &v1, const Array_n_const &v2)
Definition: Vector_n.h:346
virtual const char * consume(const blockDim &dim, vector3d *locs)=0
std::FILE * fopen(const char *const path, const char *const mode)
Open a file, and check for possible errors.
Definition: CImg.h:5494

Here is the call graph for this function:

Here is the caller graph for this function:

Variable Documentation

blockConsumer* curConsumer =NULL
static

Definition at line 67 of file read.cpp.

Definition at line 79 of file read.cpp.

Referenced by __scalegrd.f90__(), CImg< uintT >::_distance_sep(), CImg< uintT >::_draw_line(), CImg< uintT >::_draw_point(), CImg< uintT >::_draw_polygon(), CImg< uintT >::_draw_spline(), CImg< uintT >::_draw_text(), CImgList< uintT >::_load_cimg(), CImg< uintT >::_LU(), CImg< uintT >::_quicksort(), CImgList< uintT >::_save_cimg(), CImgList< uintT >::_save_empty_cimg(), CImg< uintT >::_solve(), a_d_tensors(), Window_manifold_2::accumulate_bd_values(), MsqHessian::accumulate_entries(), TerminationCriterion::accumulate_patch(), StopWatchCollection::add(), Rocmop::add_aspect_ratios(), add_hypervar(), Roccom_map< Object >::add_object(), Function_map::add_object(), add_reduced_index(), Mesh::addCohesive(), Attribute::allocate(), RFC_Pane_overlay::allocate_subfaces(), AllocateCommBuffers(), amplitude_sub(), rflu_modrepair3d::angfnd(), CImg< uintT >::append_object3d(), cimg_library::cimg::argument(), Agent::assign_attributes(), Window_manifold_2::assign_global_nodeIDs(), Overlay::associate_green_vertices(), Pane::attribute(), Window::attribute(), Pane::attributes(), QualityMetric::average_metric_and_weights(), QualityMetric::average_metrics(), avgcopatchconstant(), avgcopatchedge(), avgcopatchlinear(), Mesquite::axpy(), Rocblas::axpy_gen(), FaceOffset_3::balance_mass(), bc_enforce(), bc_sub(), prep_modbcdistribution::bcinflowveldistrib(), Pane_communicator::begin_update(), Interpolate::bilinear(), modsortsearch::binarysearchinteger(), bitmap::bitmap(), block::block(), Propagation_3::bound_facial_speed(), Propagation_3::bound_nodal_motion(), boundary_sub(), boundaryht_sub(), boundarymm_sub(), Mesh::Connectivity::BreadthFirstRenumber(), broadcast_win_attributes(), bs95setup_(), bs95solve_(), Mesh::BSExtent< T >::BSExtent(), Kdtree_d< Traits >::build(), RFC_Pane_overlay::build_hds(), tpz_ordered::build_point_index(), RFC_Pane_base::build_v2b_from_b2v(), BuildBorderStiffness(), TriFace::buildCohesive(), QuadFace::buildCohesive(), Scheduler::buildDDG(), buildFaces(), update_py::burn_get_burning_rate1d(), init_py::burn_init_1d(), burn_initialize(), Rocon::burnout(), Rocon::burnout_filter(), c3d6nm(), cal_shdx(), Rocblas::calc(), calcavgco(), Rocblas::calcDot(), Roccom_base::call_function(), Agent::callMethod(), Coupling::callMethod(), Translation_repS3< FT >::cartesian(), Translation_repS2< FT >::cartesian(), rflu_modrepair3d::cavedg(), CBox::CBox(), Mesh::GenericCell_2::Centroid(), Mesh::GenericElement::Centroid(), cg_array_core_write(), cg_array_core_write_internal(), cg_exponents_as_string_write(), MsqHessian::cg_solver(), Rocmop::check_all_elem_quality(), check_bool_arr(), Coupling::check_convergence(), check_delimiters(), Rocmop::check_displacements(), NonSmoothSteepestDescent::check_equilibrium(), VertexMover::check_feasible(), Rocmop::check_input_pconn(), Rocmop::check_marked_elem_quality(), check_non_numeric_str(), check_non_numeric_str_per(), Polyhedron_incremental_builder_3< HDS >::check_unconnected_vertices(), NonSmoothSteepestDescent::check_vector_dots(), CheckCoordinates(), checkindxrange(), checkQuality(), CkHashCompare_default(), CkHashFunction_default(), CkHashFunction_string(), NonSmoothSteepestDescent::cleanup(), PatchDataMem< X >::clear(), CornerTag< T >::clear(), points::clear_dep_vars(), MeshImplData::clear_element(), Mesh::NodalCoordinates::closest_node(), Mesh::NodalCoordinates::closest_point(), cmpct1(), cmpct2(), rflu_modrepair3d::coarsn(), rflu_modrepair3d::colaps(), Pane_connectivity::collect_boundary_nodes(), collect_coincident_nodes(), Pane_connectivity::collect_nodes(), Pane_connectivity::collect_points(), COM_call_function(), COM_F_FUNC2(), COM_icall_function(), COM_print_window(), com_set_false(), com_set_true(), com_settypeinfo(), RFC_Pane_base::comp_nat_coors(), comp_row_add(), comp_row_addval(), comp_row_getval(), comp_row_k(), comp_row_mat(), comp_row_resize(), comp_row_vecmult(), compact(), compare_key(), compareFiles(), modtools::compfact(), CImg< T >::_cimg_math_parser::compile(), compositestiffnes(), NonSmoothSteepestDescent::compute_alpha(), CompositeOFMultiply::compute_analytical_gradient(), CompositeOFAdd::compute_analytical_gradient(), CompositeOFScalarMultiply::compute_analytical_gradient(), LPtoPTemplate::compute_analytical_gradient(), LPtoPTemplate::compute_analytical_hessian(), Geo_Metric_Base_3::compute_angles(), FaceOffset_3::compute_anisotropic_vertex_centers(), MeshBndSurf::compute_bbox(), Rocsurf::compute_bounded_volumes(), Rocsurf::compute_center(), MsqMeshEntity::compute_corner_normals(), TargetCalculator::compute_default_target_matrices(), FaceOffset_3::compute_directions(), Rocsurf::compute_edge_lengths(), RI_DFT::compute_element_analytical_gradient(), IdealWeightInverseMeanRatio::compute_element_analytical_gradient(), IdealWeightMeanRatio::compute_element_analytical_gradient(), I_DFT::compute_element_analytical_gradient(), RI_DFT::compute_element_analytical_hessian(), IdealWeightInverseMeanRatio::compute_element_analytical_hessian(), IdealWeightMeanRatio::compute_element_analytical_hessian(), I_DFT::compute_element_analytical_hessian(), Rocsurf::compute_element_areas(), QualityMetric::compute_element_gradient_expanded(), QualityMetric::compute_element_hessian(), Rocsurf::compute_element_normals(), QualityMetric::compute_element_numerical_hessian(), NonSmoothSteepestDescent::compute_function(), NonSmoothSteepestDescent::compute_gradient(), TargetCalculator::compute_guide_matrices(), UniformGrid::compute_index(), compute_lbop_weights(), Transfer_base::compute_load_vector_wra(), Window_manifold_2::compute_mcn(), Rocmop::compute_medial_quadric(), Window_manifold_2::compute_nodal_normals(), FaceOffset_3::compute_quadrics(), TargetCalculator::compute_reference_corner_matrices(), Alg_Metric_Base_2::compute_shape(), Alg_Metric_Base_3::compute_shape(), Window_manifold_2::compute_shortest_edgelen_elements(), Window_manifold_2::compute_shortest_edgelen_nodes(), Rocsurf::compute_signed_volumes(), Alg_Metric_Base_3::compute_size(), Alg_Metric_Base_3::compute_skew(), Alg_Metric_Base_2::compute_skew(), Rocsurf::compute_swept_volumes(), DistanceFromTarget::compute_T_matrices(), WTargetCalculator::compute_target_matrices(), LVQDTargetCalculator::compute_target_matrices(), TargetCalculator::compute_target_matrices_and_check_det(), computeavgco(), computefacectr(), computefacewidth(), computeflux(), computefluxtot(), conductivitytensor(), connect_points::connect_points(), Pane::connectivity(), SerialProgram::ConnectivityMaps(), Rocon::constrain_displacements(), Rocmop::constrain_displacements(), Pane_dual_connectivity::construct_connectivity_str_2(), Pane_dual_connectivity::construct_connectivity_unstr(), Face::containsNode(), convert_nodelist(), convertflo2flumesh(), convertflo2flupatch(), convertWindow(), Rocblas::copy(), copy2dumcells(), NonSmoothSteepestDescent::copy_active(), Attribute::copy_array(), Mesquite::copy_from_sidl(), MeshImplData::copy_higher_order(), Transfer_base::copy_vec(), Vertex_set::count_edges(), Overlay::count_edges(), RFC_Window_transfer::counts_to_displs(), Pane_connectivity::create_b2map(), GEM_Partition::Create_com_pconn(), Agent::create_registered_attributes(), Agent::create_registered_window_attributes(), createk(), createm(), Mesh::BSExtent< T >::CreateUnstructuredMesh(), cst_coh(), ctranspose(), modsortsearch::cyclelist(), Function::data_type(), rflu_modrepair3d::datsrf(), Attribute::deallocate(), debug_int_print(), debug_print(), Action::declare(), del_original(), del_original_indices(), Window::delete_attribute(), Pane::delete_attribute(), delete_hypervar(), FaceOffset_3::denoise_surface(), rflu_modrepair3d::densfn(), In_place_list_n< T, managed >::destroy(), RFC_Window_overlay::detect_features(), Pane_boundary::determine_border_nodes_3(), Pane_boundary::determine_borders(), RFC_Pane_overlay::determine_counterparts(), Window_manifold_2::determine_counterparts(), Simple_manifold_2::determine_incident_halfedges(), Pane_boundary::determine_isolated_nodes(), Simple_manifold_2::determine_opposite_halfedges(), Rocmop::determine_pane_border(), Rocmop::determine_physical_border(), Window_manifold_2::determine_primaries(), Pane_ghost_connectivity::determine_shared_border(), Rocmop::determine_shared_border(), dirToCorner(), dist(), FaceOffset_3::distribute_volume_e2n(), Transfer_base::dot(), Transfer_base::dot2(), dot_product(), dsyevq3(), dsytrd3(), eat_whitespace_until(), rflu_modrepair3d::edgerm(), rflu_modrepair3d::edglen(), Transfer_base::element_load_vector(), Element_node_enumerator::Element_node_enumerator(), MeshImplData::element_topology(), MesqPane::elements_get_attached_vertex_indices(), MeshImpl::elements_get_attached_vertices(), MesqPane::elements_get_attached_vertices(), MesqPane::elements_get_topologies(), MeshTSTTImpl::elements_get_topologies(), Window_manifold_2::elements_to_nodes(), Propagation_3::enforce_nodal_constraints(), enforcethermalbc(), ensemble1loop(), ensemble2loops(), ensemble3lijk(), ensemble3likj(), ensemble3ljik(), ensemble3ljki(), ensemble3lkij(), ensemble3lkji(), moderror::errorstop(), CImg< T >::_cimg_math_parser::eval(), sI_DFT::evaluate_element(), sRI_DFT::evaluate_element(), RI_DFT::evaluate_element(), ASMQualityMetric::evaluate_element(), GeneralizedConditionNumberQualityMetric::evaluate_element(), IdealWeightInverseMeanRatio::evaluate_element(), IdealWeightMeanRatio::evaluate_element(), I_DFT::evaluate_element(), Rocmop::evaluate_face_normals(), RFC_Pane_overlay::evaluate_normals(), RFC_Window_overlay::evaluate_normals(), VertexConditionNumberQualityMetric::evaluate_vertex(), LocalSizeQualityMetric::evaluate_vertex(), face::face(), FaceOffset_3::FaceOffset_3(), feminp(), CImg< uintT >::FFT(), FaceOffset_3::filter_and_identify_ridge_edges(), FaceOffset_3::filter_obscended_ridge(), Coupling::finalize(), Agent::finalize(), Pane_ghost_connectivity::finalize_pconn(), NonSmoothSteepestDescent::find_active_set(), Rocon::find_intersections(), NonSmoothSteepestDescent::find_plane_normal(), NonSmoothSteepestDescent::find_plane_points(), FindMagnitudeRange(), findprobe(), FindRange(), FindTraceRange(), firstSet(), FloGridBlock::FloGridBlock(), FloGridBlock::FloLayout(), fluidpressload(), for(), NonSmoothSteepestDescent::form_grammian(), NonSmoothSteepestDescent::form_PD_grammian(), NonSmoothSteepestDescent::form_reduced_matrix(), fortranifyString(), Mesquite::Frobenius_2(), Scheduler::ActionItem::fullfilled(), Rocblas::gen2arg(), PatchData::generate_vertex_to_element_data(), NonSmoothSteepestDescent::get_active_directions(), Attribute::get_addr(), Connectivity::get_addr(), partition::get_adj(), MesqPane::get_all_elements(), MesqPane::get_all_mesh(), MesqPane::get_all_sizes(), MesqPane::get_all_vertices(), Roccom_base::get_attributes(), PatchData::get_average_Lambda_3d(), PatchData::get_barrier_delta(), FileTokenizer::get_booleans(), RFC_Pane_overlay::get_border_index(), Simple_manifold_2::get_borders(), RFC_Pane_base::get_bounding_box(), RFC_Pane_overlay::get_buffered_inode(), FileTokenizer::get_byte_internal(), FileTokenizer::get_bytes(), KNN_Grid< Tri >::get_cell(), KNN_Grid< Tri >::get_cell_range(), MsqMeshEntity::get_centroid(), connect_points::get_closest(), indexed_points::get_closest(), connect_points::get_connected_points(), indexed_points::get_connected_points(), Roccom_base::get_connectivities(), Pane_ghost_connectivity::get_cpanes(), MsqHessian::get_diagonal_blocks(), PatchData::get_domain_normals_at_corners(), FileTokenizer::get_doubles(), MeshImplTags::get_element_data(), Pane_ghost_connectivity::get_ents_to_send(), ObjectiveFunction::get_eps(), get_external_loads(), get_fint(), FileTokenizer::get_floats(), NonSmoothSteepestDescent::get_gradient_projections(), tpz_ordered::get_index_value(), Overlay::get_inodes_of_face(), FileTokenizer::get_integer_internal(), FileTokenizer::get_integers(), Action::get_io(), StopWatchCollection::get_key(), StopWatchCollection::get_keys_sorted_by_time(), Pane_connectivity::get_local_boundary_nodes(), FileTokenizer::get_long_ints(), RFC_Pane_base::get_lvid(), NonSmoothSteepestDescent::get_min_estimate(), PatchData::get_minmax_element_unsigned_area(), RFC_Pane_base::get_nat_coor_in_element(), Triangulation::get_next(), Simple_manifold_2::get_next_edge_interior(), MeshSet::get_next_elem_on_vert_patch(), Simple_manifold_2::get_next_ghost_edge_interior(), MeshSet::get_next_global_patch(), Simple_manifold_2::get_next_real_edge_interior(), Pane_ghost_connectivity::get_node_total_order(), Element_node_enumerator::get_nodes(), Facet_node_enumerator::get_nodes(), datafile::get_num_points(), ParameterSet::get_parameter_index(), datafile::get_point(), Triangulation::get_prev(), Simple_manifold_2::get_prev_edge_interior(), Simple_manifold_2::get_prev_ghost_edge_interior(), Simple_manifold_2::get_prev_real_edge_interior(), FaceOffset_3::get_primary_component(), Rocmop::get_redist_safe_factor(), FileTokenizer::get_short_int_internal(), FileTokenizer::get_short_ints(), get_sizeof(), Rocmop::get_usr_disp(), MeshImplTags::get_vertex_data(), Polyhedron_incremental_builder_3< HDS >::get_vertex_to_edge_map(), MeshImpl::get_vertex_use_count(), MesqPane::get_vertex_use_count(), tecplot_data::get_zone_header(), tecplot_data::get_zone_nodes(), Mesh::Connectivity::GetAdjacent(), getbndverttype(), block::getFaceNo(), getgrid(), modindexing::getijk(), TetElement::getMinEdgeLength(), Mesh::Connectivity::GetNeighborhood(), Mesh::GenericCell_2::GetNormalSet(), getPaneConnectivity(), PaneConnectivity::getPointConnectionPairs(), Mesh::GenericCell_2::GetPointSet(), Node::getSeparateElements(), getWindow(), glbthermcap(), glbthermstiff(), GlobalDofExchange(), GlobalDofReMapExchange(), setup_py::grid(), MeshImplTags::handle(), Scheduler::ActionItem::hasInput(), Scheduler::ActionItem::hasOutput(), heat_transfer_sub(), heatfluxload(), heatload_hex(), SerialProgram::HigherOrderTets(), CImg< uintT >::HSVtoRGB(), huang_const_model(), RFC_Window_overlay::identify_features_0(), Rocmop::identify_ridge_edges(), implicit_bc_enforce(), implicit_initialize(), implicit_soln(), implicit_v3d8_mass(), implicit_v3d8_mass_consistent(), implicit_v3d8_me_k(), In_place_list_n_base< INode, 2 >::In_place_list_n_base(), RFC_Window_transfer::incident_faces(), RFC_Window_transfer::incident_panes(), incrementAscii(), NodeList::index(), IntList::index(), ElementList::index(), FaceList::index(), FaceListList::index(), modindexing::indijkmap(), Attribute::inherit(), Pane::inherit(), InterpolateBase::init(), Pane_ghost_connectivity::init(), Pane_communicator::init(), MesqPane::init(), Coupling::init(), RFC_Pane_base::init(), Window_manifold_2::init(), Simple_manifold_2::init(), CBox::init(), init_attributes(), Agent::init_bcactions(), init_constraints_acmflu(), init_constraints_labscale(), init_constraints_myacm(), init_constraints_staraft(), init_constraints_starslice(), Coupling::init_convergence(), init_crds2_tet_unstr_2(), Pane::init_done(), Window::init_done(), RFC_Window_transfer::init_facial_buffers(), Random_access_adaptor< Vertex_iterator >::init_index(), Transfer_base::init_load_vector(), NonSmoothSteepestDescent::init_max_step_length(), RFC_Window_transfer::init_nodal_buffers(), init_normals(), NonSmoothSteepestDescent::init_opt(), init_profiling(), init_speed(), init_speed_arrays(), init_structure_mesh(), init_structured_mesh(), init_unstr_hex_coords(), init_unstructure_mesh(), VariableDimensionArray::initArray(), initcomm1(), initcomm2(), initData(), Alg_Metric_Base_2::initialize(), Alg_Metric_Base_3::initialize(), Rocon::initialize(), MsqHessian::initialize(), MeshBndSurf::initialize(), PatchData::initialize_data(), initializeflowfield(), initk(), initUnstructuredMesh(), Mesquite::inner(), Coupling::input(), inrt_twodimaverage(), rflu_modrepair3d::insert(), CImgList< uintT >::insert(), FaceOffset_3::insert_boundary_edges(), Overlay::insert_node_in_blue_edge(), RFC_Pane_overlay::insert_subface(), KNN_Grid< Tri >::insertRange(), Rocsurf::integrate(), Transfer_base::integrate(), Transfer_base::integrate_subface(), Function::intent(), Transfer_base::interpolate_fe(), Generic_element_2::interpolate_to_center(), Rocsurf::interpolate_to_centers(), InterpolateBase::InterpolateBase(), Kdtree_d< Traits >::Box::intersect(), intersect_bbox(), Overlay::intersect_blue_with_green(), MeshBndSurf::intersection(), intload(), orient_t::inverse(), Mesh::Connectivity::Inverse(), Mesh::Connectivity::InverseDegenerate(), invert(), MesqPane::invert(), Transfer_base::invert(), CImg< uintT >::invert(), invert2(), Rocmop::invert_elements(), cimg_library::cimg::invert_endianness(), Rocmop::invert_tets(), io_hdf_data(), io_pane_attribute(), io_pane_connectivity(), io_pane_coordinates(), Triangulation::is_diagonalie(), Kdtree_d< Traits >::Box::is_empty(), Kdtree_d< Traits >::Box::is_empty_open(), Roccom_map< std::pair< void *, std::set< std::string > > >::is_immutable(), Kdtree_d< Traits >::Box::is_in(), Function::is_input(), Kdtree_d< Traits >::Box::is_intersect(), CImgDisplay::is_key(), Function::is_literal(), Function::is_metadata(), Function::is_optional(), Function::is_output(), Overlay::is_queue_empty(), Function::is_rawdata(), is_whole(), jacobi(), k_average(), KNN_Grid< Tri >::k_nearest(), KNN_Grid< Tri >::KNN_Grid(), CImg< uintT >::kth_smallest(), ktinitcrs(), ktnumnnz(), points::largest_val(), lass(), Mesquite::Linf(), load_data_HDF4(), CImgList< uintT >::load_ffmpeg_external(), Roccom_base::load_module(), CImgList< uintT >::load_parrec(), SparseGrid< SpaceCell >::locate(), SparseGrid< SpaceCell >::locate_packed_index(), locthermcap_v3d8(), locthermstiff_v3d8(), bcListTop::lookup(), bcList::lookup(), MeanMidNodeMover::loop_over_mesh(), QualityAssessor::loop_over_mesh(), spec_rflu_modchemistry::lusolve(), main(), make_kd_tree(), Pane_ghost_connectivity::mark_elems_from_nodes(), Rocmop::mark_elems_from_nodes(), FaceOffset_3::mark_weak_vertices(), maskPoints(), Overlay::match_features_0(), matcoh_sub(), matmodel_elastic(), matmodel_hyperelastic(), matmul2(), Mesquite::matmult(), CImg< uintT >::matrix(), matvol_sub(), max_dt_solid(), max_element__(), modsortsearch::mergesortedintegers(), mesh2d(), mesh2doverlay(), MeshBndSurf::MeshBndSurf(), FloGridBlock::MeshLayout(), MeshTSTTImpl::MeshTSTTImpl(), micromechanical_sub(), GridConversion::MidPointQuadrature(), min_element__(), Pane_boundary::min_squared_edge_len(), Transfer_base::minmax(), Mesquite::mult_element(), Transfer_base::multiply_mass_mat_and_x(), Roccom_map< std::pair< void *, std::set< std::string > > >::name(), cimg_library::cimg::nearest_pow2(), Pane::new_attribute(), new_attributes(), newcommlist(), newton(), nodeio_sub(), Mesh::BSExtent< T >::NodeNum(), NonSmoothSteepestDescent::NonSmoothSteepestDescent(), Transfer_base::norm2(), norm_and_clean_constraints(), PlanarDomain::normal_at(), SphericalDomain::normal_at(), Normal_set::Normal_set(), Rocsurf::normalize(), Halfedge_data_structure_using_vector< V, H, F >::normalize_border(), normalize_coor(), Overlay_primitives::normalmatch(), FaceOffset_3::nulaplacian_smooth(), PatchData::num_corners(), PatchData::num_free_nodes(), PatchData::num_free_vertices(), Overlay::number_subfaces(), Overlay::number_subnodes(), numknnz(), NVec< 3, index_t >::NVec(), FaceOffset_3::obtain_constrained_directions(), Rocmop::obtain_extremal_dihedrals(), FaceOffset_3::obtain_face_offset(), rflu_modrepair3d::octfil(), rflu_modrepair3d::octfnd(), rflu_modoctree::octree(), rflu_modrepair3d::octrmv(), one_sided_normal(), N_step_adaptor< I, N, Ref, Ptr, Val, Dist, Ctg >::operator!=(), Iterator_from_circulator< C, Ref, Ptr >::operator!=(), NVec< 3, index_t >::operator()(), Element_node_vectors_k_const< Value >::operator()(), nvc::operator*(), Mesquite::operator*(), nvc::operator+(), Mesquite::operator+(), nvc::operator+=(), Circulator_from_iterator< I, TT, SS, DD >::operator+=(), nvc::operator-(), Mesquite::operator-(), nvc::operator/(), nvc::operator/=(), nvc::operator<<(), operator<<(), Mesquite::operator<<(), points::operator=(), NVec< 3, index_t >::operator=(), PatchDataMem< X >::operator=(), bitmap::operator=(), connect_points::operator=(), pnt::operator=(), VariableDimensionArray::operator=(), nvc::operator==(), N_step_adaptor< I, N, Ref, Ptr, Val, Dist, Ctg >::operator>=(), In_place_list_n< T, managed >::operator>=(), Iterator_from_circulator< C, Ref, Ptr >::operator>=(), operator>>(), nvc::operator>>(), Mesquite::operator>>(), Mesh::operator>>(), Vector_3< Real >::operator[](), Four_tuple< T >::operator[](), Vertex_set::operator[](), Roccom_map< std::pair< void *, std::set< std::string > > >::operator[](), Array_n_const::operator[](), orient_t::operator[](), Array_n::operator[](), Element_node_enumerator::operator[](), Point_3< Real >::operator[](), Element_node_enumerator_uns::operator[](), Facet_node_enumerator::operator[](), Matrix3D::operator[](), Point_2< R >::operator[](), ConjugateGradient::optimize_vertex_positions(), SteepestDescent::optimize_vertex_positions(), FeasibleNewton::optimize_vertex_positions(), Coupling::output_restart_files(), Coupling::output_visualization_files(), Mesh::BSExtent< T >::Overlap(), P_triRay(), Pane::Pane(), Pane_communicator::Pane_communicator(), Pane_node_enumerator::Pane_node_enumerator(), tecplot_data::parse(), tpz_ordered::parse_data(), tpz_fequad::parse_data(), parseArguments(), parseCmdParameters(), Kdtree_d< Traits >::partition(), partition_ceff(), face::patchForCoord(), Transfer_base::pcg(), Pane_connectivity::pconn_nblocks(), Rocmop::perform_iterative_smoothing(), peri_cnlforceterm(), peri_cocnlinitsolution(), peri_cocprinitsolution(), peri_cocprslowterms(), peri_copgradupdate(), Rocmop::perturb_stationary(), peul_bcondinflow(), peul_bcondinjection(), peul_bcondoutflow(), peul_bcondslipwall(), peul_bcondsymmetry(), peul_centraldissipation(), peul_centralflux(), peul_centralfluxpatch(), peul_correctcorneredgecells(), peul_enforcepositivity(), peul_exchangecorneredgecells(), peul_exchangedummyconf(), peul_readsolution(), peul_readsolutionregion(), peul_receivecorneredgecells(), peul_receivedummyvals(), peul_residualsmoothing(), peul_residualsmoothingcoeffs(), peul_senddummyconf(), peul_setcorneredgecells(), peul_sourceeqeul(), peul_spectralradii(), peul_writesolution(), block::pin(), plag_binsortnozzleinlet(), plag_binsortspatialdist(), plag_calcfacecentroids(), plag_cecellsexchange(), plag_cecellsfacecentroids(), plag_cecellsfacevectors(), plag_cecellsgetbuffersize(), plag_corncellsloaddata(), plag_edgecellsloaddata(), plag_getcellindices(), plag_incelltestrobust(), plag_injcejectparticle(), plag_injcsetpositions(), plag_injctestcell(), plag_injctilecalcrhs(), plag_patchgetbuffersize(), plag_processeulerfield(), plag_readsolution(), plag_readsolutionfilepost(), plag_readstatpost(), plag_rflo_modstats::plag_rflo_copystatbuff(), plag_rflo_ejectparticle(), plag_rflo_findgridmapping(), plag_rflo_modstats::plag_rflo_readstat(), plag_rflo_recvmetrics(), plag_rflo_modstats::plag_rflo_recvstatbuff(), plag_rflo_modstats::plag_rflo_sendstatbuffconf(), plag_rflo_modstats::plag_rflo_writestat(), plag_writesolution(), plag_writestattecascii(), plag_writetecplotascii(), pnt::pnt(), points::points(), data_py::polint(), Exponent::powNegativeInt(), Exponent::powPositiveInt(), Transfer_base::precondition_Jacobi(), prescribedload(), primeLargerThan(), principal_stress(), Scheduler::print(), Scheduler::ActionItem::print(), Coupling::print(), Agent::print(), NonSmoothSteepestDescent::print_active_set(), print_array(), Rocmop::print_extremal_dihedrals(), RFC_Window_overlay::print_features(), Scheduler::print_helper(), QualityAssessor::Assessor::print_histogram(), print_metrics(), Rocmop::print_mquality(), Roccom_base::print_profile(), Rocmop::print_quality(), Scheduler::print_toposort(), linked_list::print_vol_list(), Scheduler::printActions(), printBothElementalData(), printBothNodalData(), PrintConn(), printElementalData(), printNodalData(), printStackBacktrace(), printStridedElementalData(), printStridedNodalData(), PrintStructured(), PrintUnstructured(), printVtk(), probe_sub(), Pane_ghost_connectivity::process_received_data(), Coupling::ProcessInterrupt(), prep_modbcdistribution::profinflowvttaylorcyl(), Overlay::project_adjacent_green_vertices(), Overlay_primitives::project_blue_feature(), Overlay_primitives::project_onto_element(), project_window(), TestingObject< ResultsType >::Prologue(), Rocprop::propagate(), PointPropagate::propagate_faces(), PointPropagate::propagate_gp_of_element(), PointPropagate::propagate_nodes(), QuadFace::QuadFace(), modsortsearch::quicksortinteger(), modsortsearch::quicksortintegerinteger(), modsortsearch::quicksortrfreal(), modsortsearch::quicksortrfrealinteger(), radi_calcefftemp(), radi_diffradflux(), radi_diffradfluxpatch(), radi_diffradintens(), radi_extinctioncoef(), radi_flimdifffluxpatch(), radi_flimsourceterms(), radi_floflimbconddiffuse(), radi_floflimbcondinjection(), radi_floflimbcondsymmetry(), radi_floflimbcondzerograd(), radi_floflimcentflux(), radi_floflimcentfluxpatch(), radi_floflimcentraldissipation(), radi_floflimcorrcornedgecells(), radi_floflimexchangedummyconf(), radi_floflimexchcornedgecells(), radi_floflimrecvcornedgecells(), radi_floflimrecvdummyvals(), radi_floflimsenddummyconf(), radi_floflimsetcornedgecells(), radi_fluxlimiter(), radi_mixtsourcetermsflim(), radi_peulsourcetermsflim(), radi_plagsourcetermsflim(), radi_rflo_flimressmoothing(), radi_rflo_flimressmoothingcoeff(), radi_rflo_flimspectralradii(), radi_rflo_readsolution(), radi_rflo_writesolution(), Rocblas::rand(), modrandom::randimposedpdf(), modrandom::randnormal(), Randomize::randomize_vertex(), modrandom::randomseed(), modrandom::randuniform(), bcReader::read(), RFC_Pane_base::read_binary(), Rocin::read_by_control_file(), MeshImpl::read_exodus(), read_file(), read_files(), read_frac(), read_general(), read_hdf(), read_ij(), IM_Reader::read_mesh(), read_msh(), read_obj(), MSH_Reader::read_pane_coors(), OBJ_Reader::read_pane_coors(), Neutral_Reader::read_pane_coors(), IM_Reader::read_pane_coors(), OBJ_Reader::read_pane_elems(), MSH_Reader::read_pane_elems(), Neutral_Reader::read_pane_elems(), IM_Reader::read_pane_elems(), Rocin::read_parameter_file(), read_patran(), read_plot3d(), read_reg(), RFC_Pane_base::read_rocin(), MeshImpl::read_vtk(), readBlock(), readCommaExpression(), FluRegion::ReadFluGridASCII(), FluRegion::ReadFluSolnASCII(), readinitflowsection(), SerialProgram::ReadPatranInput(), readQuoteExpression(), SerialProgram::ReadStanfordInput(), setup_py::readtable(), readTopFile(), Rocmop::redistribute_vertices_ridge(), Rocmop::redistribute_vertices_smooth(), Pane_communicator::reduce_average_on_shared_nodes(), RFC_Window_overlay::reduce_coordinates_to_all(), reduce_diff(), Pane_communicator::reduce_diff_on_shared_nodes(), reduce_int(), reduce_maxabs(), Pane_communicator::reduce_maxabs_on_shared_nodes(), reduce_minabs(), Pane_communicator::reduce_minabs_on_shared_nodes(), Pane_communicator::reduce_on_shared_nodes(), reduce_real(), RFC_Pane_base::register_sdv_attributes(), RegisterCommBuffers(), Pane::reinit_attr(), FaceOffset_3::remove_obscure_curves(), Polyhedron_incremental_builder_3< HDS >::remove_unconnected_vertices(), removebcht_newtemp(), removebcht_reff(), removebcs_meff(), removebcs_newa(), removebcs_pbar(), Mesh::removeElement(), Node::removeElement(), Mesh::removeFace(), Node::removeFace(), Mesh::removeNode(), PatchData::reorder(), rflu_modrepair3d::replace(), Element::replaceFace(), TCoElement::replaceFaceNode(), QCoElement::replaceFaceNode(), Element::replaceNode(), Mesh::replaceNode(), Face::replaceNode(), RFC_Window_transfer::replicate_data(), RFC_Window_transfer::replicate_metadata(), FaceOffset_3::rescale_displacements(), PatchDataMem< X >::resize(), FloGridBlock::Resize(), In_place_list_n< T, managed >::resize(), PatchDataMem< X >::resize_storage(), FloGridBlock::ResizeSoln(), Coupling::restart_at_time(), rflo_arclengthbounds(), rflo_modboundaryconditions::rflo_bcondfarfield(), rflo_modboundaryconditions::rflo_bcondinflow(), rflo_modboundaryconditions::rflo_bcondinjection(), rflo_modboundaryconditions::rflo_bcondinjectionapn(), rflo_modboundaryconditions::rflo_bcondinjectioninit(), rflo_modboundaryconditions::rflo_bcondnoslipwall(), rflo_modboundaryconditions::rflo_bcondoutflow(), rflo_modboundaryconditions::rflo_bcondslipwall(), rflo_modboundaryconditions::rflo_bcondsymmetry(), rflo_modgridregionshape::rflo_blockskewedcell(), rflo_c2favgcoeffsdummyconn(), rflo_c2favgcoeffsdummyphys(), rflo_calccellcentroids(), rflo_calccontrolvolumes(), rflo_calcfacevectors(), rflo_calcforces(), rflo_calcgraddummyconn(), rflo_calcgraddummyphys(), rflo_calcgraddummysymm(), rflo_calcgradfaces(), rflo_calcgradphysbc(), rflo_calcgridspeeds(), rflo_calcmassflow(), rflo_calcsidegrad(), rflo_calcthrust(), rflo_calctotalmass(), rflo_centraldissipation(), rflo_centralflux(), rflo_centralfluxpatch(), rflo_changeinteriorgrid(), rflo_checkmetrics(), rflo_checkregionfaces(), rflo_checkvalidity(), rflo_computeintegralvalues(), rflo_modforcesmoments::rflo_computepatchforcemomco(), rflo_copyedgefacenorm(), rflo_copyedgefaceparal(), rflo_copyedgegrad(), rflo_copygeometrydummy(), rflo_copymatrixcorners(), rflo_copymatrixedges(), rflo_copymatrixpatches(), rflo_copypatchedgegrad(), rflo_copyvectorcorners(), rflo_copyvectoredges(), rflo_copyvectorpatches(), rflo_correctcorneredgecells(), rflo_dualtstpredict(), rflo_modelliptsmoothing::rflo_elliptgridgauss2d(), rflo_modelliptsmoothing::rflo_elliptgridgauss3d(), rflo_modelliptsmoothing::rflo_elliptgridjac2d(), rflo_modelliptsmoothing::rflo_elliptgridjac3d(), rflo_modelliptsmoothing::rflo_elliptgridpatch(), rflo_modelliptsmoothing::rflo_elliptgridsmoo(), rflo_modelliptsmoothing::rflo_elliptgridsmooregion(), rflo_modelliptsmoothing::rflo_elliptgridsor2d(), rflo_modelliptsmoothing::rflo_elliptgridsor3d(), rflo_modelliptsmoothing::rflo_elliptmatrixcoeffs2d(), rflo_modelliptsmoothing::rflo_elliptmatrixcoeffs3d(), rflo_exchangecorneredgecells(), rflo_exchangednodecopy(), rflo_exchangednoderecv(), rflo_exchangednodesend(), rflo_exchangedummyconf(), rflo_exchangegeometrycopy(), rflo_exchangegeometrylevels(), rflo_exchangegeometryrecv(), rflo_exchangegeometrysend(), rflo_extrapintcellscal(), rflo_extrapintcellvec(), rflo_modextrapolation::rflo_extrapregdummynode(), rflo_modextrapolation::rflo_extrapreglastnode(), rflo_moddegeneratecornedge::rflo_finddegeneratcell(), rflo_modfinitedifference::rflo_findiffcompi(), rflo_modfinitedifference::rflo_findiffcompii(), rflo_modfinitedifference::rflo_findiffcompiis(), rflo_modfinitedifference::rflo_findiffcompis(), rflo_modfinitedifference::rflo_findiffcompj(), rflo_modfinitedifference::rflo_findiffcompjj(), rflo_modfinitedifference::rflo_findiffcompjjs(), rflo_modfinitedifference::rflo_findiffcompjs(), rflo_modfinitedifference::rflo_findiffcompk(), rflo_modfinitedifference::rflo_findiffcompkk(), rflo_modforcesmoments::rflo_findpatchcoeffsglo(), rflo_findsourceregions(), rflo_findthrustpatches(), rflo_finishgradpatchconstant(), rflo_finishgradpatchlinear(), rflo_generatecoarsegrids(), rflo_getboundaryvalues(), rflo_getdeformation(), rflo_modgridcontrolmap::rflo_gridcontrolfunc2d(), rflo_modgridcontrolmap::rflo_gridcontrolfunc3d(), rflo_modgridcontrolmap::rflo_gridcontrolmap2d(), rflo_modgridcontrolmap::rflo_gridcontrolmap3d(), rflo_modgridcontrolmap::rflo_gridphysgrad2d(), rflo_gridremesh(), rflo_interpoldistrib(), rflo_modlaplacesmoothing::rflo_laplacegridjump(), rflo_modlaplacesmoothing::rflo_laplacegridortho(), rflo_modlaplacesmoothing::rflo_laplacegridortho1(), rflo_modlaplacesmoothing::rflo_laplacegridortho2(), rflo_modlaplacesmoothing::rflo_laplacegridpatch(), rflo_laplacegridpatch(), rflo_modlaplacesmoothing::rflo_laplacegridsmoo(), rflo_laplacegridsmoo(), rflo_modlaplacesmoothing::rflo_laplacegridsolve(), rflo_laplacegridsolve(), rflo_moddegeneratecornedge::rflo_markdegeneratvert(), rflo_modmovegridframe::rflo_mgframebroadcast(), rflo_modmovegridframe::rflo_mgframecorrectneighbors(), rflo_modmovegridframe::rflo_mgframerestoreexternal(), rflo_modmovegridframe::rflo_mgframesrchneighbors(), rflo_openprobefile(), rflo_readbcfromfile(), rflo_readgrid(), rflo_readgridregion(), rflo_readrandomstate(), rflo_readsolution(), rflo_readsolutionregion(), rflo_readstat(), rflo_readstatregion(), rflo_receivecorneredgecells(), rflo_receivedummyvals(), rflo_residualnorm(), rflo_residualsmoothing(), rflo_residualsmoothingcoeffs(), rflo_roedissipfirst(), rflo_roedissipsecond(), rflo_roefluxfirst(), rflo_roefluxpatch(), rflo_roefluxsecond(), rflo_sendboundaryvalues(), rflo_sendboundaryvaluesalpha(), rflo_senddummyconf(), rflo_setcorneredgecells(), rflo_modstatsboundaryconditions::rflo_statbcondcopy(), rflo_modstatsboundaryconditions::rflo_statbcondextrap(), rflo_modstatsboundaryconditions::rflo_statbcondnegate(), rflo_timestepinviscid(), rflo_timestepviscous(), rflo_viscousfluxpatch(), rflo_modvolmeshsmoothing::rflo_vmsaveragevertices(), rflo_modvolmeshsmoothing::rflo_vmslaplaceiterate(), rflo_modvolmeshsmoothing::rflo_vmslaplaceperturb(), rflo_modvolmeshsmoothing::rflo_vmsprojectvertices(), rflo_modvolmeshsmoothing::rflo_vmsrestorebounddeform(), rflo_writegrid(), rflo_writegridregion(), rflo_writerandomstate(), rflo_writesolution(), rflo_writesolutionregion(), rflo_writestat(), rflo_zerodummycells(), rflu_modtopologyutils::rflu_buildcellvertlist(), rflu_modtopologyutils::rflu_buildconnvertlist(), rflu_modtopologyutils::rflu_buildfacevertlist(), rflu_modregionmapping::rflu_buildregionmappingsimple(), rflu_modregionmapping::rflu_checkregionmapping(), rflu_modoles::rflu_computegeometrictermsoles(), rflu_computeintegral1oles(), rflu_computeintegral4oles(), rflu_computeintegralvalues(), rflu_computeweightsoles(), rflu_modweights::rflu_computewtsx2c_1d(), rflu_convfluxoles(), rflu_modmesh3d::rflu_convmesh3d2rocflu(), rflu_modvgridns::rflu_convvgridns2rocflu(), rflu_modoles::rflu_definecorrelation32(), rflu_modoles::rflu_definecorrelation430(), rflu_modoles::rflu_definecorrelation431(), rflu_modoles::rflu_definecorrelation432(), rflu_modrenumberlist::rflu_denumberlist(), rflu_modextractflowdata::rflu_extractflowdatablasius(), rflu_modextractflowdata::rflu_extractflowdataproudman(), rflu_modhashtable::rflu_findnearestprime(), rflu_modhashtable::rflu_hashbuildkey(), rflu_invertmatrixsvd(), rflu_modoles::rflu_mapk2ij(), rflu_modoles::rflu_mapl2ijk(), rflu_modoles::rflu_mapm2ijkl(), rflu_modpartitionregion::rflu_part_addvirtualcells(), rflu_modpartitionregionutils::rflu_part_addvirtualcellsinv2(), rflu_modpartitionregion::rflu_part_buildcelllists(), rflu_modpartitionregion::rflu_part_createcelllists(), rflu_modpetscpoisson::rflu_petsc_buildpoisson(), rflu_modpetscnewtonkrylov::rflu_petsc_createcoloring(), rflu_modoctree::rflu_queryoctree(), rflu_modreadbcinputfile::rflu_readbcfarfsection(), rflu_modreadbcinputfile::rflu_readbcinflowtotangsection(), rflu_modreadbcinputfile::rflu_readbcinflowveltempsection(), rflu_modreadbcinputfile::rflu_readbcinjectsection(), rflu_modreadbcinputfile::rflu_readbcnoslipwallheatsect(), rflu_modreadbcinputfile::rflu_readbcnoslipwalltempsect(), rflu_modreadwritegrid::rflu_readgridascii(), rflu_modreadwritegrid::rflu_readgridbinary(), rflu_modcentaur::rflu_readgridcentaurascii(), rflu_modcentaur::rflu_readgridcentaurbinary(), rflu_modmesh3d::rflu_readgridmesh3d(), rflu_modtetmesh::rflu_readgridtetmesh(), rflu_modvgridns::rflu_readgridvgridns(), rflu_readintegrals1245oles(), rflu_modrenumberlist::rflu_renumberlist(), rflu_modrenumberlist::rflu_renumberlist2(), rflu_modoles::rflu_setmapfunnz2funcorr32(), rflu_modoles::rflu_setmapfunnz2funcorr43(), rflu_modsymmetryperiodic::rflu_sype_addvirtualcellsinv2(), rflu_modtimezoom::rflu_timezoomcomputebulkvars(), rflu_modreadwritegrid::rflu_writegridascii(), rflu_modreadwritegrid::rflu_writegridbinary(), rflu_writeintegrals1245oles(), rflu_modregionmapping::rflu_writeregionmappingfile(), rm_constraint(), Roccom_base::Roccom_base(), rocflo_2dto3d(), rocflo_blocks(), rocfracmain::rocfracinitialize(), rocfracsubinterface::rocfracinterfaceinitial(), rocfracprep(), rocfracmain::rocfracsoln(), rocfracmain::rocfracupdateinbuff(), rockout_8node(), rocvav_post(), Coupling::run(), SerialProgram::Run(), Agent::run_bcinitaction(), rvav_blasiussolution(), rvav_computeerror(), rvav_computesimilarfield(), rvav_gammbumpsolution(), rvav_plotresults(), rvav_proudmanculicksolution(), rvav_readfilestream1(), rvav_readfilestream2analyt(), rvav_readfilestream2comput(), rvav_readfilestream2experm(), Scheduler::sanityCheck(), CImgList< uintT >::save_ffmpeg(), Transfer_base::saxpy(), Transfer_base::scale(), scale_mesh(), scan_files_HDF4(), Scheduler::schedule(), Coupling::schedule(), Agent::schedule(), NonSmoothSteepestDescent::search_direction(), NonSmoothSteepestDescent::search_edges_faces(), searchTopFile(), Pane_ghost_connectivity::send_gelem_lists(), Pane_ghost_connectivity::send_pane_info(), serialbs95_(), serialbs95mat_(), serialbs95tridiag_(), Window_manifold_2::serialize_window(), Element_node_vectors_k_const< Value >::set(), MeshTSTTImpl::set_active_set(), PatchData::set_all_vertices_soft_fixed(), PatchData::set_all_vertices_soft_free(), Action::set_attr(), RFC_Pane_overlay::set_buffered_inode(), connect_points::set_connectivity(), TerminationCriterion::set_debug_output_level(), MeshImplData::set_element(), MeshImplTags::set_element_data(), Roccom_base::set_f90pointer(), PatchData::set_free_vertices_soft_fixed(), Roccom_base::set_function(), Roccom_base::set_function_verbose(), INode::set_id(), RFC_Pane_overlay::set_inode(), manual_index_pts::set_layout(), Roccom_base::set_member_function_helper(), FaceOffset_3::set_normal_diffusion(), points::set_num_points(), Attribute::set_pointer(), Roccom_base::set_profiling(), bitmap::set_size(), Attribute::set_size(), MsqDebug::set_stream(), MeshImplTags::set_vertex_data(), Polyhedron_incremental_builder_3< HDS >::set_vertex_to_edge_map(), TCoElement::setFromMyNodes(), QCoElement::setFromMyNodes(), Element::setFromNodes(), Mesh::GenericCell_2::shapef_jacobian_at(), Mesh::GenericElement::shapef_jacobian_at(), Node::sharedFace(), shcalc(), shcalc_3d10(), shift_P(), Remesher_Simmetrix::simmesh_to_window(), Pane_connectivity::size_of_cpanes(), rflu_modrepair3d::sliver(), points::smallest_val(), rflu_modrepair3d::smooth(), Rocmop::smooth_surf_medial(), Rocmop::smooth_vol_mesq_ng(), Rocmop::smooth_vol_mesq_wg(), Overlay_primitives::snap_blue_ridge_vertex(), Generic_element_2::solve(), CImg< uintT >::solve(), CImg< uintT >::solve_tridiagonal(), solve_x(), In_place_list_n< T, managed >::sort(), Overlay::sort_on_green_edges(), CImg< uintT >::sphere3d(), In_place_list_n< T, managed >::splice(), Halfedge_data_structure_decorator< _HDS >::split_loop(), splitgrid(), squared_sum(), NonSmoothSteepestDescent::step_acceptance(), stitchGrids(), stitchSolutionData(), Agent::store_solutions(), rflu_modrepair3d::struct(), block::subBlock(), RFC_Window_overlay::subdiv_feature_curve(), Overlay::subdivide(), CImg< uintT >::SVD(), Rocblas::swap(), Mesh::BSExtent< T >::Sync(), Mesh::Connectivity::SyncSizes(), MesqPane::tag_create(), MeshTSTTImpl::tag_get_data(), MesqPane::tag_get_element_data(), MesqPane::tag_get_vertex_data(), MeshTSTTImpl::tag_set_data(), MesqPane::tag_set_element_data(), MesqPane::tag_set_vertex_data(), tensormul(), rflu_modrepair3d::tessel(), TestingObject< ResultsType >::Test__MidPointQuadrature(), TestingObject< ResultsType >::Test__TrapezoidQuadrature(), testconst(), TestMPI(), Fileselect::testTecplot(), rflu_modrepair3d::tetmv(), thermal_initialize(), thermal_soln(), FaceOffset_3::time_stepping(), to_double(), Scheduler::topological_sort(), tql1(), tql2(), tractload(), tractload_hex(), tractloaddef(), tractloadpress_hex(), tractpressload(), tractpressloaddef(), TRAIL_AutoSurfer(), TRAIL_ExtractSurf0(), TRAIL_FD2FE_Transfer(), TRAIL_File2Window(), TRAIL_FixRocstarData(), TRAIL_FluReadGridASCII(), TRAIL_Get_Block_Structured_Neighbors(), TRAIL_RocpropSmoothSurf(), TRAIL_Search_Block_Structured_Pool(), TRAIL_TransferSurfDataFILE(), TRAIL_UniqueAcrossProcs(), TRAIL_Window2UnstructuredMesh(), TRAIL_WriteWindow(), Transfer_base::transfer_2f(), TransformCoordinates(), VariableDimensionArray::translate_coord_to_index(), VariableDimensionArray::translate_index_to_coords(), Mesquite::transpose(), trapezoid1loop(), trapezoid2loops(), trapezoid3lijk(), trapezoid3likj(), trapezoid3ljik(), trapezoid3ljki(), trapezoid3lkij(), trapezoid3lkji(), GridConversion::TrapezoidQuadrature(), tred1(), tred2(), Triangulation::triangulate(), tridg(), TriFace::TriFace(), rflu_modrepair3d::triswp(), turb_calcvortic(), turb_coranswalldistov(), turb_floextrapintcellscal(), turb_floextrapintcellvec(), turb_floextrapolcellvec(), turb_floextrapolfacevec(), turb_flofacevolume(), turb_flofacewidthdummyconn(), turb_flofacewidthdummyphys(), turb_flolesaverageface(), turb_flolesgenc2f(), turb_flolesgencocchi(), turb_flolesgencocclo(), turb_flolesgencofchi(), turb_flolesgencofclo(), turb_flolesgencoffhi(), turb_flolesgencofflo(), turb_flolesgenfiltcci(), turb_flolesgenfiltccj(), turb_flolesgenfiltcck(), turb_flolesgenfiltffi(), turb_flolesgenfiltffj(), turb_flolesgenfiltffk(), turb_flolesunifiltcci(), turb_flolesunifiltccj(), turb_flolesunifiltcck(), turb_flolesunifiltffi(), turb_flolesunifiltffj(), turb_flolesunifiltffk(), turb_floransbcondinflow(), turb_floransbcondinjection(), turb_floransbcondnoslipwall(), turb_floransbcondsymmetry(), turb_floransbcondzerograd(), turb_floranscentraldissipation(), turb_floranscorrcornedgecells(), turb_floransexchangedummyconf(), turb_floransexchcornedgecells(), turb_floransrecvcornedgecells(), turb_floransrecvdummyvals(), turb_floranssacentflux(), turb_floranssacentfluxpatch(), turb_floranssaroe1stflux(), turb_floranssaroe2ndflux(), turb_floranssaroefluxpatch(), turb_floranssenddummyconf(), turb_floranssetcornedgecells(), turb_flowlmmetric(), turb_flowlmupdateloglay(), turb_getmodelstresscell(), turb_gettvcell(), turb_lescalceddyvis(), turb_lesesgmodel4(), turb_ranssasourceterms(), turb_ranssavisfluxpatch(), turb_ranswalldistovpatch(), turb_rflo_ransressmoothing(), turb_rflo_ransressmoothingcoeff(), turb_rflo_ransspectralradii(), turb_rflo_readsolution(), turb_rflo_readsolutionregion(), turb_rflo_writesolution(), turb_statccollector(), turb_vfluxhybridpatch(), turb_visfluxeddypatch(), turb_wlmfluxpatch(), turb_wlminitia(), turb_wlmreyanalogy(), turb_wlmtauwallmapping(), Window_manifold_2::update_bd_flags(), Window_manifold_2::update_bd_normals(), Window_manifold_2::update_bdedge_bitmap(), Rocmop::update_buf_real_nc(), PatchData::update_cached_normals(), Pane_communicator::update_ghost_values(), FullyCoupling::update_integrals(), MeshSet::update_mesh(), update_value(), FaceOffset_3::update_vertex_centers(), updateHash(), updatestructuralsoln::updatestructuralht(), updatetbcpiecewise(), v3d10(), v3d10_ale(), v3d10_b_bar(), v3d10_capacitance(), v3d10_mass(), v3d10_nl(), v3d10_nl_arruda_boyce(), v3d10_nl_arruda_boyce_damping(), v3d10_nl_arruda_boyce_thermal(), v3d10_nl_damping(), v3d10_nl_huang(), v3d10_nl_matous(), v3d10_r_bar(), v3d10_thermal(), v3d10_thermalexp(), v3d10r_nl(), v3d4(), v3d4_ale(), v3d4_capacitance(), v3d4_damping(), v3d4_mass(), v3d4_neohookeancompress(), v3d4_neohookeanincompress(), v3d4_neohookeanincompressdef(), v3d4_neohookeanincompressprin(), v3d4_nl(), v3d4_nl_arruda_boyce(), v3d4_r_bar(), v3d4_thermal(), v3d4_thermalexp(), v3d4_thermalexp2(), v3d4_volume(), v3d4n(), v3d4n_mass(), v3d4n_neohookeancompress(), v3d4n_neohookeanincompress(), v3d4n_nl(), v3d4n_nl_arruda_boyce(), v3d8_mass(), v3d8_me(), NonSmoothSteepestDescent::validity_check(), VariableDimensionArray::VariableDimensionArray(), vecmatvecmul(), Vectize(), Overlay::verify_inode(), Element_node_enumerator::vertex(), MesqPane::vertex_get_attached_elements(), Vertex_set::Vertex_set(), MeshImpl::vertices_are_on_boundary(), MesqPane::vertices_are_on_boundary(), MeshTSTTImpl::vertices_are_on_boundary(), MesqPane::vertices_get_attached_elements(), MeshImpl::vertices_get_byte(), MesqPane::vertices_get_byte(), MeshTSTTImpl::vertices_get_byte(), MeshImpl::vertices_get_coordinates(), MesqPane::vertices_get_coordinates(), MeshTSTTImpl::vertices_get_coordinates(), MesqPane::vertices_get_fixed_flag(), MeshImpl::vertices_set_byte(), MesqPane::vertices_set_byte(), MeshTSTTImpl::vertices_set_byte(), vol_elem_mat(), vol_elem_mat_matous(), vol_elem_mat_ortho(), VOLUME_LASSERRE_FILE(), MeshImpl::vtk_read_field(), MeshImpl::vtk_read_polygons(), MeshImpl::vtk_read_rectilinear_grid(), MeshImpl::vtk_read_scalar_attrib(), MeshImpl::vtk_read_structured_points(), MeshImpl::vtk_read_unstructured_grid(), MeshImpl::vtk_write_attrib_data(), QualityMetric::weighted_average_metrics(), Window::Window(), Remesher_Simmetrix::window_to_simmesh(), write_attr_CGNS(), Mesh::write_boundary(), write_bounds(), write_data(), MeshImpl::write_exodus(), write_fortran(), MeshSet::write_gnuplot(), write_grda(), write_grdb(), write_hdf(), write_ij(), Overlay::write_inodes_tec(), Overlay::write_inodes_vec(), write_msh(), write_output(), write_output_2(), Overlay::write_overlay_off(), Rocout::write_parameter_file(), Rocout::write_rocin_control_file(), RFC_Pane_base::write_tec_ij(), RFC_Pane_base::write_tec_mixed(), RFC_Pane_base::write_tec_sub(), RFC_Pane_base::write_tec_tri(), MeshImpl::write_vtk(), MeshSet::write_vtk(), prep_modbcdistribution::writebctofile(), writeBlocks(), flowprobe::WriteData(), WriteElements(), writeflugrid(), FluRegion::WriteFluGridASCII(), FluRegion::WriteFluSolnASCII(), writegeneric(), SerialProgram::WriteOutput(), TecplotOrderedWriter::writePartition(), writePlotFile(), writeprobe(), writesurfacegrid(), writetecplotascii(), writetecplotbinary(), Mesh::writeVtkData(), writeVtkData(), writeVtkFiles(), CPoint::x(), CVector::x(), C3Vector::x(), CPoint::y(), CVector::y(), C3Vector::y(), CPoint::z(), CVector::z(), C3Vector::z(), Rocmop::zero_displacements(), MsqHessian::zero_out(), zn_calc_burning_rate(), zn_gen_grid(), zn_sswsb(), Action::~Action(), block::~block(), Coupling::~Coupling(), datafile::~datafile(), face::~face(), HexElement::~HexElement(), Mesh::~Mesh(), Pane::~Pane(), points::~points(), QCoElement::~QCoElement(), QuadFace::~QuadFace(), SparseGrid< SpaceCell >::~SparseGrid(), TCoElement::~TCoElement(), TetElement::~TetElement(), and TriFace::~TriFace().

void int * ni

Definition at line 77 of file read.cpp.

Referenced by Rocmop::add_aspect_ratios(), add_ghost_nodes2D(), AllocateCommBuffers(), Mesh::Connectivity::BreadthFirstRenumber(), Rocblas::calcDot(), Rocmop::check_all_elem_quality(), Rocmop::check_displacements(), Rocmop::check_input_pconn(), Rocmop::check_marked_elem_quality(), Roccom_base::clone_attribute(), Geo_Metric_Base_3::compute_angles(), Rocmop::compute_medial_quadric(), Rocmop::constrain_displacements(), Pane_dual_connectivity::construct_connectivity_str_2(), Attribute::copy_array(), Roccom_base::copy_attribute(), Pane_boundary::determine_border_nodes_3(), Simple_manifold_2::determine_incident_halfedges(), eat_whitespace_until(), Transfer_base::element_load_vector(), Mesh::Connectivity::ElementsOn(), FloGridBlock::FloGridBlock(), MesqPane::get_all_sizes(), Rocmop::get_usr_disp(), Mesh::Connectivity::GetAdjacent(), Mesh::Connectivity::GetNeighborhood(), Pane::inherit(), Rocmop::invert_elements(), Rocmop::invert_tets(), main(), Rocmop::obtain_extremal_dihedrals(), FloGridBlock::operator=(), Rocmop::perturb_stationary(), Rocmop::print_extremal_dihedrals(), Rocmop::print_mquality(), Rocmop::print_quality(), read_msh(), Rocin::read_parameter_file(), FloGridBlock::ReadBlock(), FloGridBlock::ReadBlockSoln(), rflo_modfinitedifference::rflo_findiffcompiis(), rflo_modfinitedifference::rflo_findiffcompis(), rflo_modfinitedifference::rflo_findiffcompjjs(), rflo_modfinitedifference::rflo_findiffcompjs(), Roccom_base::set_f90pointer(), Rocmop::smooth_vol_mesq_ng(), Roccom_base::split_name(), TRAIL_FD2FE_WinCreate(), TRAIL_FluWriteCOM(), Rocmop::update_buf_real_nc(), Roccom_base::use_attribute(), MesqPane::vertices_get_attached_elements(), write_grda(), write_grdb(), write_msh(), Rocout::write_parameter_file(), FluRegion::WriteFluCOM(), and Rocmop::zero_displacements().

void int int * nj

Definition at line 74 of file read.cpp.

Referenced by Rocmop::add_aspect_ratios(), add_ghost_nodes2D(), Pane_communicator::begin_update(), Propagation_3::bound_facial_speed(), Rocblas::calcDot(), Rocmop::check_displacements(), Geo_Metric_Base_3::compute_angles(), FaceOffset_3::compute_anisotropic_vertex_centers(), Rocmop::compute_medial_quadric(), FaceOffset_3::compute_quadrics(), Rocmop::constrain_displacements(), Pane_dual_connectivity::construct_connectivity_str_2(), Propagation_3::convert_constraints(), FaceOffset_3::denoise_surface(), Pane_boundary::determine_border_nodes_3(), Pane_boundary::determine_borders(), Propagation_3::determine_constraint_boundary(), Window_manifold_2::determine_counterparts(), Rocmop::determine_physical_border(), Window_manifold_2::determine_primaries(), Pane_ghost_connectivity::determine_shared_border(), Rocmop::determine_shared_border(), FaceOffset_3::distribute_volume_e2n(), MesqPane::elements_get_attached_vertices(), Rocmop::evaluate_face_normals(), CImg< uintT >::FFT(), FaceOffset_3::filter_and_identify_ridge_edges(), Pane_ghost_connectivity::finalize_pconn(), MesqPane::get_all_mesh(), Pane_ghost_connectivity::get_cpanes(), Pane_ghost_connectivity::get_ents_to_send(), Pane_ghost_connectivity::get_node_total_order(), Rocmop::get_redist_safe_factor(), Rocmop::get_usr_disp(), Rocmop::identify_ridge_edges(), Pane::inherit(), FaceOffset_3::insert_boundary_edges(), MesqPane::invert(), main(), FaceOffset_3::mark_weak_vertices(), FaceOffset_3::nulaplacian_smooth(), Rocmop::perturb_stationary(), PointPropagate::propagate_faces(), PointPropagate::propagate_nodes(), read_msh(), read_plot3d(), FloGridBlock::ReadBlock(), FloGridBlock::ReadBlockSoln(), FaceOffset_3::reclassify_ridge_vertices(), Rocmop::redistribute_vertices_smooth(), FaceOffset_3::rescale_displacements(), rflo_modfinitedifference::rflo_findiffcompiis(), rflo_modfinitedifference::rflo_findiffcompis(), rflo_modfinitedifference::rflo_findiffcompjjs(), rflo_modfinitedifference::rflo_findiffcompjs(), Pane_ghost_connectivity::send_gelem_lists(), Pane_ghost_connectivity::send_pane_info(), Rocmop::smooth_vol_mesq_ng(), rflu_modrepair3d::tree(), Rocmop::update_buf_real_nc(), write_grda(), write_grdb(), write_msh(), and Rocmop::zero_displacements().

vector3d* v =curConsumer->allocateBlock(dim)

Definition at line 78 of file read.cpp.

void int int int REAL * x

Definition at line 74 of file read.cpp.

Referenced by __scalegrd.f90__(), CImg< uintT >::_atX(), CImg< uintT >::_atXY(), CImg< uintT >::_atXYZ(), CImg< uintT >::_atXYZV(), CImg< uintT >::_autocrop(), CImg< uintT >::_cubic_atX(), CImg< uintT >::_cubic_atXY(), CImg< uintT >::_display_object3d(), CImg< uintT >::_draw_line(), CImg< uintT >::_draw_polygon(), CImg< uintT >::_draw_scanline(), CImg< uintT >::_draw_spline(), CImg< uintT >::_draw_text(), CImgList< uintT >::_font(), CImg< uintT >::_linear_atX(), CImg< uintT >::_linear_atXY(), CImg< uintT >::_linear_atXYZ(), CImg< uintT >::_linear_atXYZV(), CImg< uintT >::_load_bmp(), CImgDisplay::_render_resize(), CImg< uintT >::_save_raw(), CGAL::abs(), CGAL::NTS::abs(), Rocblas::acos(), Rocblas::add_scalar(), rflu_modrepair3d::angfnd(), Assert_compile_time_tag(), CImgList< uintT >::atN(), cimg_library::cimg::atof(), CImg< uintT >::atX(), CImg< uintT >::atXY(), CImg< uintT >::atXYZ(), CImg< uintT >::atXYZV(), Rocblas::axpy(), Rocblas::axpy_scalar(), PointS2< FT >::bbox(), PointS3< FT >::bbox(), CImg< uintT >::blur_anisotropic(), CImg< uintT >::blur_bilateral(), Propagation_3::bound_axial_disp(), Propagation_3::bound_radial_disp(), bs95solve_(), face::buildPatches(), GeoPrim::C3Centroid(), c3d6nm(), C3Plane::C3Plane(), Rocblas::calcChoose(), PointS2< FT >::cartesian(), VectorS2< FT >::cartesian(), VectorS3< FT >::cartesian(), PointS3< FT >::cartesian(), rflu_modrepair3d::cavbnd(), rflu_modrepair3d::cavedg(), rflu_modrepair3d::cavity(), GeoPrim::Centroid(), cg_array_core_write_internal(), rflu_modrepair3d::circum(), rflu_modrepair3d::circum2(), circumcenter(), cmp_signed_dist_to_plane(), rflu_modrepair3d::coarsn(), rflu_modrepair3d::colaps(), SegmentS2< FT >::collinear_has_on(), COM_F_FUNC2(), com_getptr_chr0d(), com_getptr_chr1d(), com_getptr_dbl0d(), com_getptr_dbl1d(), com_getptr_dbl2d(), com_getptr_dbl3d(), com_getptr_flt0d(), com_getptr_flt1d(), com_getptr_flt2d(), com_getptr_flt3d(), com_getptr_int0d(), com_getptr_int1d(), com_getptr_int2d(), com_getptr_int3d(), com_mapptr_chr1d(), com_mapptr_dbl0d(), com_mapptr_dbl1d(), com_mapptr_dbl2d(), com_mapptr_dbl3d(), com_mapptr_flt0d(), com_mapptr_flt1d(), com_mapptr_flt2d(), com_mapptr_flt3d(), com_mapptr_int0d(), com_mapptr_int1d(), com_mapptr_int2d(), com_mapptr_int3d(), COM_print_window(), UniformGrid::compute_index(), CImgList< uintT >::contains(), Rocblas::copy(), Rocblas::copy_helper(), Rocblas::copy_scalar(), CPlane::CPlane(), cst_coh(), CImg< uintT >::cubic_atX(), CImg< uintT >::cubic_atXY(), rflu_modrepair3d::datsrf(), rflu_modrepair3d::densfn(), rflu_modrepair3d::dihed(), DirectionS2< FT >::DirectionS2(), Rocblas::div_scalar(), Rocblas::dot_MPI(), Rocblas::dot_scalar_MPI(), CImg< uintT >::draw_axis(), CImg< uintT >::draw_circle(), CImg< uintT >::draw_fill(), CImg< uintT >::draw_image(), CImg< uintT >::draw_line(), CImg< uintT >::draw_mandelbrot(), CImg< uintT >::draw_rectangle(), CImg< uintT >::draw_triangle(), rflu_modrepair3d::edgerm(), rflu_modrepair3d::edglen(), Rocmop::eigen_analyze_vertex(), CImg< uintT >::elevation3d(), cimg_library::cimg::endianness(), CImg< T >::_cimg_math_parser::eval(), GridConversion::Excluded(), rflu_modrepair3d::facear(), rflu_modrepair3d::fangle(), feminp(), CImg< uintT >::FFT(), face::fillNeighbors(), for(), Data_accessorS2< FT_ >::get(), CImg< uintT >::get_blur_patch(), CImg< uintT >::get_correlate(), CImgList< uintT >::get_crop_font(), CImg< uintT >::get_dilate(), CImg< uintT >::get_distance(), CImg< uintT >::get_elevation3d(), CImg< uintT >::get_erode(), get_external_loads(), get_face_volume(), CImg< uintT >::get_gradient(), CImg< uintT >::get_haar(), CImg< uintT >::get_hessian(), CImg< uintT >::get_label_regions(), CImg< uintT >::get_matrix_at(), CImg< uintT >::get_norm(), CImg< uintT >::get_projections2d(), CImg< uintT >::get_resize(), CImg< uintT >::get_rotate(), face::getSourceLoc(), setup_py::grid(), has_larger_signed_dist_to_plane(), has_smaller_signed_dist_to_plane(), SerialProgram::HigherOrderTets(), implicit_v3d8_mass(), init_constraints_acmflu(), init_constraints_starslice(), init_crds1_tet_unstr_2(), Mesh::NodalCoordinates::init_node(), init_prism_tet_unit_coords(), rflu_modrepair3d::input(), rflu_modrepair3d::insert(), In_place_list_n< T, managed >::insert(), Overlay::insert_node_in_blue_edge(), Overlay::insert_node_in_green_edge(), KNN_Grid< Tri >::insertRange(), Generic_element_2::interpolate_to_center(), Overlay::intersect_blue_with_green(), Exponent::inverse(), Exponent::invSquare(), CGAL::is_positive(), CGAL::NTS::is_positive(), RayS2< FT >::is_vertical(), modtools::isnan(), KNN_Grid< Tri >::k_nearest(), CImg< uintT >::linear_atX(), CImg< uintT >::linear_atXY(), CImg< uintT >::linear_atXYZ(), CImg< uintT >::linear_atXYZV(), rflu_modrepair3d::lock(), main(), modtools::makenonzero(), GridConversion::MakeProject(), face::markPatched(), Overlay::match_features_0(), CGAL::NTS::max(), Rocblas::max_MPI(), Rocblas::max_scalar_MPI(), Rocblas::maxof_scalar(), midpoint(), CGAL::NTS::min(), Rocblas::min_MPI(), Rocblas::min_scalar_MPI(), CImg< uintT >::mirror(), Rocblas::mul_scalar(), Rocblas::neg(), rflu_modrepair3d::neighb(), newton(), face::nodesMatch(), CImg< uintT >::normalize(), rflu_modrepair3d::octfil(), rflu_modrepair3d::octfnd(), rflu_modrepair3d::octrmv(), Rocblas::maxof< T >::operator()(), Rocblas::swapp< T >::operator()(), CImgList< uintT >::operator()(), VectorS2< FT >::operator*(), VectorS3< FT >::operator*(), VectorS2< FT >::operator+(), VectorS3< FT >::operator+(), VectorS2< FT >::operator-(), VectorS3< FT >::operator-(), VectorS2< FT >::operator/(), VectorS3< FT >::operator/(), PointS2< FT >::operator==(), VectorS2< FT >::operator==(), VectorS3< FT >::operator==(), PointS3< FT >::operator==(), operator>>(), Overlay::overlay(), Overlay::overlay_init(), P_triRay(), tpz_ordered::parse_data(), peri_printuserinput(), VectorS2< FT >::perpendicular(), peul_printuserinput(), plag_binsortnozzleinlet(), plag_binsortspatialdist(), plag_printuserinput(), plag_processeulerfield(), plag_writestattecascii(), plag_writetecplotascii(), CImg< uintT >::plane3d(), PointS2< FT >::PointS2(), PointS3< FT >::PointS3(), data_py::polint(), Exponent::pow1(), Exponent::pow2(), Exponent::powNegativeInt(), Exponent::powPositiveInt(), principal_stress(), printpostinput(), printprepinput(), printtofluinput(), Coupling::ProcessInterrupt(), Overlay::project_adjacent_green_vertices(), Overlay_primitives::project_blue_feature(), Overlay::project_next_vertex(), projection(), rflu_modrepair3d::putpnt(), modsortsearch::quicksortinteger(), modsortsearch::quicksortintegerinteger(), modsortsearch::quicksortrfreal(), modsortsearch::quicksortrfrealinteger(), rflu_modrepair3d::radrat(), Rocblas::rand(), read_msh(), Rocin::read_windows(), rflu_modrepair3d::recon(), Rocblas::reduce_MPI(), Rocblas::reduce_scalar_MPI(), rflu_modrepair3d::replace(), rescale_object(), ResolveLink(), rflo_checkvalidity(), rflo_gridremesh(), rflo_initflowsolver(), rflo_modmovegridelliptfra::rflo_movegridelliptfra(), rflo_modmovegridelliptglo::rflo_movegridelliptglo(), rflo_modmovegridframe::rflo_movegridframe(), rflo_movegridglobal(), rflo_modvolmeshsmoothing::rflo_movegridvms(), rflo_printuserinput(), rflo_timestepping(), rflo_moddegeneratecornedge::rflo_writedegeneratec(), rflo_modforcesmoments::rflo_writepatchcoeffsinfo(), rflu_modbilinearpatch::rflu_blin_findclosestpoint(), rflu_modexactflow::rflu_computeexactflowculick(), rflu_computeexactflowerror(), rflu_modexactflow::rflu_computeexactflowpacoust(), rflu_computeexactflowprobeerror(), rflu_modexactflow::rflu_computeexactflowproudman(), rflu_modexactflow::rflu_computeexactflowringleb(), rflu_modexactflow::rflu_computeexactflowssvortex(), rflu_modplottingvars::rflu_computeplottingvarsgraderr(), rflu_modweights::rflu_computewtsx2c_1d(), rflu_modextractflowdata::rflu_extractflowdatablasius(), rflu_modextractflowdata::rflu_extractflowdataproudman(), rflu_modextractflowdatautils::rflu_extractshocklocation1d(), rflu_flowsolver(), rflu_modrocstartools::rflu_genx_constraindisp(), rflu_modrocstartools::rflu_genx_initbflag(), rflu_modincelltest::rflu_ict_testfacequadbilinear(), rflu_initbcdatahardcode(), rflu_initflowhardcode(), rflu_initflowhardcodelim(), rflu_modbessel::rflu_jyndd(), rflu_modbessel::rflu_jyzo(), rflu_modpetscnewtonkrylov::rflu_petsc_formresidual(), rflu_modpetscnewtonkrylov::rflu_petsc_formresidualfirstorder(), rflu_modpetscpoisson::rflu_petsc_solvepressurepoisson(), rflu_modrepair3d::rflu_repair3d(), rflu_modexactflow::rflu_setexactflowlinear(), rflu_modexactflow::rflu_setexactflowtrig(), rflu_modtimezoom::rflu_timezoomcomputebulkvars(), rflu_modtimezoom::rflu_timezoomsumaddsource(), rflu_modtimezoom::rflu_timezoomsumresiduals(), rflu_user_getdeformation(), rflu_writeintegrals1245oles(), cimg_library::cimg::round(), rvav_plotresults(), scalerotatevector(), NonSmoothSteepestDescent::search_direction(), serialbs95_(), serialbs95tridiag_(), CImg< uintT >::set_linear_atXY(), CImg< uintT >::set_linear_atXYZ(), HDS_accessor< Tag_true >::set_parent(), CImg< uintT >::set_tensor_at(), BoundingBox::setCoordinates(), CGAL::sign(), CGAL::NTS::sign(), rflu_modrepair3d::sliver(), smallestelement(), rflu_modrepair3d::smooth(), rflu_modrepair3d::snglar(), solve_x(), spec_rflu_initflowhardcode(), spec_rflu_modchemistry::spec_rflu_integratechemsrcterm(), Rocblas::sqrt(), Vortex_flow::square(), LeVeque_flow::square(), Propagation_3::square(), Transfer_base::square(), square(), squared_circumradiusC2(), stripdir(), rflu_modrepair3d::struct(), Rocblas::sub_scalar(), Rocblas::sum_MPI(), Rocblas::sum_scalar_MPI(), summary(), CImg< uintT >::SVD(), Rocblas::swap(), rflu_modrepair3d::tessel(), rflu_modrepair3d::tetang(), rflu_modrepair3d::tetar(), rflu_modrepair3d::tetar2(), rflu_modrepair3d::tetar3(), rflu_modrepair3d::tetcof(), rflu_modrepair3d::tetloc(), rflu_modrepair3d::tetmod(), rflu_modrepair3d::tetmv(), TRAIL_FindSourceTime(), TRAIL_GetRocstarDumpStrings(), TRAIL_ResolveLink(), TRAIL_TimeString(), GeoPrim::Transpose(), CImg< uintT >::transpose(), rflu_modrepair3d::triswp(), v3d10_capacitance(), v3d10_mass(), v3d4_capacitance(), v3d4_mass(), v3d8_mass(), VectorS3< FT >::VectorS3(), vol_elem_mat_ortho(), rflu_modrepair3d::volcom(), rflu_modrepair3d::volput(), MeshImpl::vtk_create_structured_elems(), MeshImpl::write_exodus(), write_fortran(), write_grda(), write_grdb(), write_hdf(), write_msh(), write_output(), write_output_2(), writeconvergence(), TecplotOrderedWriter::writePoints(), writetecplotascii(), writetecplotbinary(), Vector_3< Real >::x(), Point_3< Real >::x(), Vector_2< T >::x(), Point_2< R >::x(), and zn_gen_grid().

void int int int REAL REAL * y

Definition at line 74 of file read.cpp.

Referenced by __scalegrd.f90__(), CImg< uintT >::_atX(), CImg< uintT >::_atXY(), CImg< uintT >::_atXYZ(), CImg< uintT >::_atXYZV(), CImg< uintT >::_autocrop(), CImg< uintT >::_cubic_atX(), CImg< uintT >::_cubic_atXY(), CImg< uintT >::_display_object3d(), CImg< uintT >::_draw_ellipse(), CImg< uintT >::_draw_line(), CImg< uintT >::_draw_object3d(), CImg< uintT >::_draw_point(), CImg< uintT >::_draw_polygon(), CImg< uintT >::_draw_spline(), CImg< uintT >::_draw_text(), CImg< uintT >::_draw_triangle(), CImgList< uintT >::_font(), CImg< uintT >::_get_permute_axes(), CImg< uintT >::_linear_atX(), CImg< uintT >::_linear_atXY(), CImg< uintT >::_linear_atXYZ(), CImg< uintT >::_linear_atXYZV(), CImg< uintT >::_load_bmp(), CImg< uintT >::_load_jpeg(), CImg< uintT >::_load_png(), CImg< uintT >::_load_pnm(), CImgDisplay::_render_resize(), CImg< uintT >::_save_png(), CImg< uintT >::_save_raw(), Rocblas::add_scalar(), CImgList< uintT >::atN(), cimg_library::cimg::atof(), CImg< uintT >::atX(), CImg< uintT >::atXY(), CImg< uintT >::atXYZ(), CImg< uintT >::atXYZV(), Rocblas::axpy(), Rocblas::axpy_scalar(), PointS2< FT >::bbox(), PointS3< FT >::bbox(), CImg< uintT >::blur_anisotropic(), CImg< uintT >::blur_bilateral(), Propagation_3::bound_radial_disp(), face::buildPatches(), GeoPrim::C3Centroid(), C3Plane::C3Plane(), Rocblas::calc(), Rocblas::calcChoose(), Rocblas::calcDot(), PointS2< FT >::cartesian(), VectorS2< FT >::cartesian(), VectorS3< FT >::cartesian(), PointS3< FT >::cartesian(), GeoPrim::Centroid(), circumcenter(), SegmentS2< FT >::collinear_has_on(), CImgList< uintT >::contains(), CPlane::CPlane(), CImg< uintT >::cross(), CImg< uintT >::cubic_atX(), CImg< uintT >::cubic_atXY(), CImg< uintT >::deriche(), DirectionS2< FT >::DirectionS2(), CImg< uintT >::distance_hamilton(), Rocblas::div_scalar(), Rocblas::dot_MPI(), Rocblas::dot_scalar_MPI(), CImg< uintT >::draw_axis(), CImg< uintT >::draw_circle(), CImg< uintT >::draw_fill(), CImg< uintT >::draw_gaussian(), CImg< uintT >::draw_grid(), CImg< uintT >::draw_image(), CImg< uintT >::draw_line(), CImg< uintT >::draw_mandelbrot(), CImg< uintT >::draw_quiver(), CImg< uintT >::draw_rectangle(), CImg< uintT >::draw_triangle(), CImg< uintT >::edge_tensors(), CImg< uintT >::elevation3d(), CImg< T >::_cimg_math_parser::eval(), CImg< uintT >::eval(), CImg< uintT >::FFT(), CImg< uintT >::fill(), for(), Rocblas::gen2arg(), Data_accessorS2< FT_ >::get(), CImg< uintT >::get_BayertoRGB(), CImg< uintT >::get_blur_median(), CImg< uintT >::get_blur_patch(), CImg< uintT >::get_correlate(), CImg< uintT >::get_crop(), CImg< uintT >::get_dilate(), CImg< uintT >::get_displacement_field(), CImg< uintT >::get_distance(), CImg< uintT >::get_elevation3d(), CImg< uintT >::get_erode(), CImg< uintT >::get_gradient(), CImg< uintT >::get_haar(), CImg< uintT >::get_hessian(), CImg< uintT >::get_index(), CImg< uintT >::get_label_regions(), CImg< uintT >::get_matrix_at(), CImg< uintT >::get_norm(), CImg< uintT >::get_projections2d(), CImg< uintT >::get_pseudoinvert(), CImg< uintT >::get_resize(), CImg< uintT >::get_resize_doubleXY(), CImg< uintT >::get_resize_halfXY(), CImg< uintT >::get_resize_tripleXY(), CImg< uintT >::get_RGBtoBayer(), CImg< uintT >::get_rotate(), CImg< uintT >::get_select_graph(), CImg< uintT >::get_structure_tensor(), CImg< uintT >::get_tensor_at(), CImg< uintT >::get_vector_at(), CImg< uintT >::get_warp(), face::getSourceLoc(), SerialProgram::HigherOrderTets(), init_constraints_starslice(), init_crds1_tet_unstr_2(), Mesh::NodalCoordinates::init_node(), init_prism_tet_unit_coords(), Overlay::insert_node_in_green_edge(), RayS2< FT >::is_horizontal(), CImg< uintT >::isosurface3d(), KNN_Grid< Tri >::k_nearest(), CImg< uintT >::linear_atX(), CImg< uintT >::linear_atXY(), CImg< uintT >::linear_atXYZ(), CImg< uintT >::linear_atXYZV(), spec_rflu_modchemistry::lusolve(), main(), face::markPatched(), matous_const_model(), CImg< uintT >::max(), Rocblas::max_scalar_MPI(), Rocblas::maxof_scalar(), midpoint(), CImg< uintT >::min(), Rocblas::min_scalar_MPI(), CImg< uintT >::mirror(), Rocblas::mul_scalar(), CImg< uintT >::normalize(), spec_rflu_modchemistry::odesolve(), CImg< uintT >::offset(), one_sided_normal(), CImg< uintT >::operator%=(), CImg< uintT >::operator&=(), Rocblas::limit1v< T >::operator()(), Rocblas::assn< T_src, T_trg >::operator()(), Rocblas::maxof< T >::operator()(), Rocblas::swapp< T >::operator()(), Rocblas::sumv< T >::operator()(), Rocblas::nega< T >::operator()(), Rocblas::sqrta< T >::operator()(), Rocblas::acosa< T >::operator()(), CImg< uintT >::operator()(), CImgList< uintT >::operator()(), VectorS2< FT >::operator*(), VectorS3< FT >::operator*(), CImg< uintT >::operator*=(), VectorS2< FT >::operator+(), VectorS3< FT >::operator+(), CImg< uintT >::operator+=(), VectorS2< FT >::operator-(), VectorS3< FT >::operator-(), CImg< uintT >::operator-=(), VectorS2< FT >::operator/(), VectorS3< FT >::operator/(), CImg< uintT >::operator/=(), PointS2< FT >::operator==(), VectorS2< FT >::operator==(), VectorS3< FT >::operator==(), PointS3< FT >::operator==(), operator>>(), CImg< uintT >::operator^=(), CImg< uintT >::operator|=(), tpz_ordered::parse_data(), VectorS2< FT >::perpendicular(), plag_writetecplotascii(), CImg< uintT >::plane3d(), PointS2< FT >::PointS2(), PointS3< FT >::PointS3(), data_py::polin2(), data_py::polint(), CImg< uintT >::pow(), cimg_library::cimg::prand(), principal_stress(), projection(), LineS2< FT >::projection(), CImg< uintT >::ptr(), modrandom::randuniform(), read_msh(), rescale_object(), rflu_modbilinearpatch::rflu_blin_findclosestpoint(), rflu_modexactflow::rflu_computeexactflowculick(), rflu_computeexactflowerror(), rflu_modexactflow::rflu_computeexactflowpacoust(), rflu_computeexactflowprobeerror(), rflu_modexactflow::rflu_computeexactflowproudman(), rflu_modexactflow::rflu_computeexactflowringleb(), rflu_modexactflow::rflu_computeexactflowssvortex(), rflu_modplottingvars::rflu_computeplottingvarsgraderr(), rflu_modextractflowdata::rflu_extractflowdatablasius(), rflu_modextractflowdata::rflu_extractflowdataproudman(), rflu_modrocstartools::rflu_genx_constraindisp(), rflu_modrocstartools::rflu_genx_initbflag(), rflu_modincelltest::rflu_ict_testfacequadbilinear(), rflu_initbcdatahardcode(), rflu_initflowhardcode(), rflu_modexactflow::rflu_setexactflowlinear(), rflu_modexactflow::rflu_setexactflowtrig(), rflu_settransportvars(), rflu_modtimezoom::rflu_timezoomcomputebulkvars(), rflu_modtimezoom::rflu_timezoomsumaddsource(), rflu_modtimezoom::rflu_timezoomsumresiduals(), rflu_user_getdeformation(), cimg_library::cimg::round(), scalerotatevector(), CImg< uintT >::set_linear_atXY(), CImg< uintT >::set_linear_atXYZ(), CImg< uintT >::set_matrix_at(), CImg< uintT >::set_tensor_at(), CImg< uintT >::set_vector_at(), BoundingBox::setCoordinates(), CImg< uintT >::sharpen(), smallestelement(), spec_rflu_initflowhardcode(), spec_rflu_modchemistry::spec_rflu_integratechemsrcterm(), CImg< uintT >::sphere3d(), squared_circumradiusC2(), Rocblas::sub_scalar(), Rocblas::sum_scalar_MPI(), CImg< uintT >::SVD(), Rocblas::swap(), CImg< uintT >::symmetric_eigen(), CImg< uintT >::torus3d(), CImg< uintT >::translate(), GeoPrim::Transpose(), CImg< uintT >::transpose(), VectorS3< FT >::VectorS3(), vol_elem_mat_ortho(), MeshImpl::vtk_create_structured_elems(), MeshImpl::write_exodus(), write_fortran(), write_grda(), write_grdb(), write_hdf(), write_msh(), TecplotOrderedWriter::writePoints(), writetecplotbinary(), Vector_3< Real >::y(), Point_3< Real >::y(), Vector_2< T >::y(), and Point_2< R >::y().