Skip to content

Commit

Permalink
Merge pull request #2449 from luzpaz/misc-typos
Browse files Browse the repository at this point in the history
Docstring typos' corrections.
  • Loading branch information
SergioRAgostinho committed Sep 19, 2018
2 parents 48b1359 + adec4c6 commit a63431b
Show file tree
Hide file tree
Showing 60 changed files with 74 additions and 74 deletions.
4 changes: 2 additions & 2 deletions 2d/include/pcl/2d/impl/edge.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -352,7 +352,7 @@ pcl::Edge<PointInT, PointOutT>::detectEdgeCanny (pcl::PointCloud<PointOutT> &out
convolution_.filter (*smoothed_cloud);
//PCL_ERROR ("Gaussian blur: %g\n", tt.toc ()); tt.tic ();

// Edge detection usign Sobel
// Edge detection using Sobel
pcl::PointCloud<PointXYZIEdge>::Ptr edges (new pcl::PointCloud<PointXYZIEdge>);
setInputCloud (smoothed_cloud);
detectEdgeSobel (*edges);
Expand Down Expand Up @@ -431,7 +431,7 @@ pcl::Edge<PointInT, PointOutT>::canny (
convolution_.filter (smoothed_cloud_y);


// Edge detection usign Sobel
// Edge detection using Sobel
pcl::PointCloud<PointXYZIEdge>::Ptr edges (new pcl::PointCloud<PointXYZIEdge>);
sobelMagnitudeDirection (smoothed_cloud_x, smoothed_cloud_y, *edges.get ());

Expand Down
2 changes: 1 addition & 1 deletion CHANGES.md
Original file line number Diff line number Diff line change
Expand Up @@ -1917,7 +1917,7 @@ pcl::OrganizedDataIndex -> pcl::search::OrganizedNeighbor
* Update: remove ciminpack dependency and rely on eigen for LM
* Fixed a bug in ICP-NL by modifying `WarpPointRigid` to preserve the value of the 4th coordinate when warping; Re-enabled missing unit tests for ICP and ICP-NL
* Added point-to-plane ICP
* added nr_iterations_ and max_iterations_ to the initializer list (were mising)
* added nr_iterations_ and max_iterations_ to the initializer list (were missing)
* Fixed bugs in `WarpPointRigid3D` and `TransformationEstimationLM`
* fixed a problem where if no correspondences would be found via `nearestKSearch`, the RANSAC-based rejection scheme would fail (thanks to James for reporting this)
* changed the default LM implementation to use L2 instead of L2SQR
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -123,7 +123,7 @@ class CloudEditorWidget : public QGLWidget
void
cut ();

/// @brief Enters the mode where users are able to translate the selecte
/// @brief Enters the mode where users are able to translate the selected
/// points.
void
transform ();
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -76,7 +76,7 @@ class CommandQueue
void
execute (CommandPtr);

/// @brief Undoes the last command by poping the tail of the queue, invoke
/// @brief Undoes the last command by popping the tail of the queue, invoke
/// the undo function of the command.
void
undo ();
Expand Down
4 changes: 2 additions & 2 deletions cmake/Modules/NSIS.template.in
Original file line number Diff line number Diff line change
Expand Up @@ -861,7 +861,7 @@ Section "Uninstall"
@CPACK_NSIS_DELETE_ICONS@
@CPACK_NSIS_DELETE_ICONS_EXTRA@

;Delete empty start menu parent diretories
;Delete empty start menu parent directories
StrCpy $MUI_TEMP "$SMPROGRAMS\$MUI_TEMP"

startMenuDeleteLoop:
Expand All @@ -880,7 +880,7 @@ Section "Uninstall"
Delete "$SMPROGRAMS\$MUI_TEMP\Uninstall.lnk"
@CPACK_NSIS_DELETE_ICONS_EXTRA@

;Delete empty start menu parent diretories
;Delete empty start menu parent directories
StrCpy $MUI_TEMP "$SMPROGRAMS\$MUI_TEMP"

secondStartMenuDeleteLoop:
Expand Down
4 changes: 2 additions & 2 deletions common/include/pcl/common/eigen.h
Original file line number Diff line number Diff line change
Expand Up @@ -238,10 +238,10 @@ namespace pcl
* \ingroup common
*/
inline Eigen::Affine3f
getTransformationFromTwoUnitVectors (const Eigen::Vector3f& y_direction,
getTransformationFromTwoUnitVectors (const Eigen::Vector3f& y_direction,
const Eigen::Vector3f& z_axis);

/** \brief Get the transformation that will translate \a orign to (0,0,0) and rotate \a z_axis into (0,0,1)
/** \brief Get the transformation that will translate \a origin to (0,0,0) and rotate \a z_axis into (0,0,1)
* and \a y_direction into a vector with x=0 (or into (0,1,0) should \a y_direction be orthogonal to \a z_axis)
* \param[in] y_direction the y direction
* \param[in] z_axis the z-axis
Expand Down
2 changes: 1 addition & 1 deletion common/include/pcl/common/generate.h
Original file line number Diff line number Diff line change
Expand Up @@ -65,7 +65,7 @@ namespace pcl
CloudGenerator ();

/** Constructor with single generator to ensure all X, Y and Z values are within same range
* \param params paramteres for X, Y and Z values generation. Uniqueness is ensured through
* \param params parameters for X, Y and Z values generation. Uniqueness is ensured through
* seed incrementation
*/
CloudGenerator (const GeneratorParameters& params);
Expand Down
2 changes: 1 addition & 1 deletion common/include/pcl/pcl_exports.h
Original file line number Diff line number Diff line change
Expand Up @@ -36,7 +36,7 @@
#define PCL_EXPORTS_H_

// This header is created to include to NVCC compiled sources.
// Header 'pcl_macros' is not suitable since it inludes <Eigen/Core>,
// Header 'pcl_macros' is not suitable since it includes <Eigen/Core>,
// which can't be eaten by nvcc (it's too weak)

#if defined WIN32 || defined _WIN32 || defined WINCE || defined __MINGW32__
Expand Down
2 changes: 1 addition & 1 deletion cuda/common/include/pcl/cuda/cutil.h
Original file line number Diff line number Diff line change
Expand Up @@ -849,7 +849,7 @@ extern "C" {
exit(EXIT_FAILURE); \
} } while(0);

//! Check if conditon is true (flexible assert)
//! Check if condition is true (flexible assert)
# define CUT_CONDITION( val) \
if( CUTFalse == cutCheckCondition( val, __FILE__, __LINE__)) { \
exit(EXIT_FAILURE); \
Expand Down
2 changes: 1 addition & 1 deletion doc/tutorials/content/pcl_visualizer.rst
Original file line number Diff line number Diff line change
Expand Up @@ -439,7 +439,7 @@ window. We must store the view port ID number that is passed back in the
fifth parameter and use it in all other calls where we only want to
affect that viewport.

We also set the background colour of this viewport, give it a lable
We also set the background colour of this viewport, give it a label
based on what we are using the viewport to distinguish, and add our
point cloud to it, using an RGB colour handler.

Expand Down
2 changes: 1 addition & 1 deletion doc/tutorials/content/remove_outliers.rst
Original file line number Diff line number Diff line change
Expand Up @@ -62,7 +62,7 @@ For the *ConditionalRemoval* class, the user must specify '-c' as the command li
:language: cpp
:lines: 38-53

Basically, we create the condition which a given point must satisfy for it to remain in our PointCloud. In this example, we use add two comparisons to the conditon: greater than (GT) 0.0 and less than (LT) 0.8. This condition is then used to build the filter.
Basically, we create the condition which a given point must satisfy for it to remain in our PointCloud. In this example, we use add two comparisons to the condition: greater than (GT) 0.0 and less than (LT) 0.8. This condition is then used to build the filter.

In both cases the code above creates the filter object that we are going to use and sets certain parameters that are necessary for the filtering to take place.

Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -115,7 +115,7 @@ main (int argc, char** argv)
else
{
setUnseenToMaxRange = true;
cout << "\nNo *.pcd file given => Genarating example point cloud.\n\n";
cout << "\nNo *.pcd file given => Generating example point cloud.\n\n";
for (float x=-0.5f; x<=0.5f; x+=0.01f)
{
for (float y=-0.5f; y<=0.5f; y+=0.01f)
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -109,7 +109,7 @@ main (int argc, char** argv)
else
{
setUnseenToMaxRange = true;
cout << "\nNo *.pcd file given => Genarating example point cloud.\n\n";
cout << "\nNo *.pcd file given => Generating example point cloud.\n\n";
for (float x=-0.5f; x<=0.5f; x+=0.01f)
{
for (float y=-0.5f; y<=0.5f; y+=0.01f)
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -282,7 +282,7 @@ main (int argc, char** argv)
// ------------------------------------
pcl::PointCloud<pcl::PointXYZ>::Ptr basic_cloud_ptr (new pcl::PointCloud<pcl::PointXYZ>);
pcl::PointCloud<pcl::PointXYZRGB>::Ptr point_cloud_ptr (new pcl::PointCloud<pcl::PointXYZRGB>);
std::cout << "Genarating example point clouds.\n\n";
std::cout << "Generating example point clouds.\n\n";
// We're going to make an ellipse extruded along the z-axis. The colour for
// the XYZRGB cloud will gradually go from red to green to blue.
uint8_t r(255), g(15), b(15);
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -87,7 +87,7 @@ main(int argc, char** argv)
// copies all inliers of the model computed to another PointCloud
pcl::copyPointCloud<pcl::PointXYZ>(*cloud, inliers, *final);

// creates the visualization object and adds either our orignial cloud or all of the inliers
// creates the visualization object and adds either our original cloud or all of the inliers
// depending on the command line arguments specified.
boost::shared_ptr<pcl::visualization::PCLVisualizer> viewer;
if (pcl::console::find_argument (argc, argv, "-f") >= 0 || pcl::console::find_argument (argc, argv, "-sf") >= 0)
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -92,7 +92,7 @@ main (int argc, char** argv)
}
else
{
cout << "\nNo *.pcd file given => Genarating example point cloud.\n\n";
cout << "\nNo *.pcd file given => Generating example point cloud.\n\n";
for (float x=-0.5f; x<=0.5f; x+=0.01f)
{
for (float y=-0.5f; y<=0.5f; y+=0.01f)
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -102,7 +102,7 @@ main (int argc, char** argv)
}
else
{
std::cout << "\nNo *.pcd file given => Genarating example point cloud.\n\n";
std::cout << "\nNo *.pcd file given => Generating example point cloud.\n\n";
for (float x=-0.5f; x<=0.5f; x+=0.01f)
{
for (float y=-0.5f; y<=0.5f; y+=0.01f)
Expand Down
2 changes: 1 addition & 1 deletion examples/features/example_rift_estimation.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -86,7 +86,7 @@ main (int, char** argv)
gradient_est.setSearchMethod(treept2);
gradient_est.setRadiusSearch(0.25);
gradient_est.compute(*cloud_ig);
std::cout<<" Intesity Gradient estimated";
std::cout<<" Intensity Gradient estimated";
std::cout<<" with size "<< cloud_ig->points.size() <<std::endl;


Expand Down
2 changes: 1 addition & 1 deletion features/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -159,7 +159,7 @@ if(build)
)

if(MSVC)
# Workaround to aviod hitting the MSVC 4GB linker memory limit when building pcl_features.
# Workaround to avoid hitting the MSVC 4GB linker memory limit when building pcl_features.
# Disable whole program optimization (/GL) and link-time code generation (/LTCG).
string(REPLACE "/GL" "" CMAKE_CXX_FLAGS_RELEASE ${CMAKE_CXX_FLAGS_RELEASE})
string(REPLACE "/LTCG" "" CMAKE_SHARED_LINKER_FLAGS_RELEASE ${CMAKE_SHARED_LINKER_FLAGS_RELEASE})
Expand Down
2 changes: 1 addition & 1 deletion features/include/pcl/features/rops_estimation.h
Original file line number Diff line number Diff line change
Expand Up @@ -110,7 +110,7 @@ namespace pcl
setTriangles (const std::vector <pcl::Vertices>& triangles);

/** \brief Returns the triangles of the mesh.
* \param[out] triangles triangles of tthe mesh
* \param[out] triangles triangles of the mesh
*/
void
getTriangles (std::vector <pcl::Vertices>& triangles) const;
Expand Down
2 changes: 1 addition & 1 deletion filters/include/pcl/filters/impl/frustum_culling.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -83,7 +83,7 @@ pcl::FrustumCulling<PointT>::applyFilter (std::vector<int> &indices)
Eigen::Vector4f pl_l; // left plane

Eigen::Vector3f view = camera_pose_.block (0, 0, 3, 1); // view vector for the camera - first column of the rotation matrix
Eigen::Vector3f up = camera_pose_.block (0, 1, 3, 1); // up vector for the camera - second column of the rotation matix
Eigen::Vector3f up = camera_pose_.block (0, 1, 3, 1); // up vector for the camera - second column of the rotation matrix
Eigen::Vector3f right = camera_pose_.block (0, 2, 3, 1); // right vector for the camera - third column of the rotation matrix
Eigen::Vector3f T = camera_pose_.block (0, 3, 3, 1); // The (X, Y, Z) position of the camera w.r.t origin

Expand Down
2 changes: 1 addition & 1 deletion filters/include/pcl/filters/sampling_surface_normal.h
Original file line number Diff line number Diff line change
Expand Up @@ -144,7 +144,7 @@ namespace pcl

private:

/** \brief @b CompareDim is a comparator object for sorting across a specific dimenstion (i,.e X, Y or Z)
/** \brief @b CompareDim is a comparator object for sorting across a specific dimension (i,.e X, Y or Z)
*/
struct CompareDim
{
Expand Down
2 changes: 1 addition & 1 deletion filters/include/pcl/filters/voxel_grid_covariance.h
Original file line number Diff line number Diff line change
Expand Up @@ -520,7 +520,7 @@ namespace pcl
/** \brief Flag to determine if voxel structure is searchable. */
bool searchable_;

/** \brief Minimum points contained with in a voxel to allow it to be useable. */
/** \brief Minimum points contained with in a voxel to allow it to be usable. */
int min_points_per_voxel_;

/** \brief Minimum allowable ratio between eigenvalues to prevent singular covariance matrices. */
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -113,7 +113,7 @@ namespace pcl
const Eigen::Vector3i& in_target_voxel);

/** \brief Computes the voxel coordinates (i, j, k) of all occluded
* voxels in the voxel gird.
* voxels in the voxel grid.
* \param[out] occluded_voxels the coordinates (i, j, k) of all occluded voxels
* \return 0 upon success and -1 if an error occurs
*/
Expand Down
2 changes: 1 addition & 1 deletion gpu/kinfu/src/internal.h
Original file line number Diff line number Diff line change
Expand Up @@ -341,7 +341,7 @@ namespace pcl
PCL_EXPORTS size_t
extractCloud (const PtrStep<short2>& volume, const float3& volume_size, PtrSz<PointType> output);

/** \brief Performs normals computation for given poins using tsdf volume
/** \brief Performs normals computation for given points using tsdf volume
* \param[in] volume tsdf volume
* \param[in] volume_size volume size
* \param[in] input points where normals are computed
Expand Down
2 changes: 1 addition & 1 deletion gpu/kinfu/tools/record_tsdfvolume.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -375,7 +375,7 @@ main (int argc, char* argv[])
// parse input cloud file
pc::parse_argument (argc, argv, "-cf", cloud_file);

// pase output volume file
// parse output volume file
pc::parse_argument (argc, argv, "-vf", volume_file);

// parse options to extract and save cloud from volume
Expand Down
4 changes: 2 additions & 2 deletions gpu/kinfu/tools/tsdf_volume.h
Original file line number Diff line number Diff line change
Expand Up @@ -241,11 +241,11 @@ EIGEN_MAKE_ALIGNED_OPERATOR_NEW
// template <typename PointT> void
// createFromCloud (const typename pcl::PointCloud<PointT>::ConstPtr &cloud, const Intr &intr);

/** \brief Retunrs the 3D voxel coordinate */
/** \brief Returns the 3D voxel coordinate */
template <typename PointT> void
getVoxelCoord (const PointT &point, Eigen::Vector3i &voxel_coord) const;

/** \brief Retunrs the 3D voxel coordinate and point offset wrt. to the voxel center (in mm) */
/** \brief Returns the 3D voxel coordinate and point offset wrt. to the voxel center (in mm) */
template <typename PointT> void
getVoxelCoordAndOffset (const PointT &point, Eigen::Vector3i &voxel_coord, Eigen::Vector3f &offset) const;

Expand Down
2 changes: 1 addition & 1 deletion gpu/kinfu/tools/tsdf_volume.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -204,7 +204,7 @@ pcl::TSDFVolume<VoxelT, WeightT>::getVoxelCoord (const PointT &point, Eigen::Vec
}


/** \brief Retunrs the 3D voxel coordinate and point offset wrt. to the voxel center (in mm) */
/** \brief Returns the 3D voxel coordinate and point offset wrt. to the voxel center (in mm) */
template <typename VoxelT, typename WeightT> template <typename PointT> void
pcl::TSDFVolume<VoxelT, WeightT>::getVoxelCoordAndOffset (const PointT &point,
Eigen::Vector3i &coord, Eigen::Vector3f &offset) const
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -300,7 +300,7 @@ namespace pcl
pcl::device::kinfuLS::Mat33& transform_out, float3& translation_out);

/** \brief helper function that pre-process a raw detph map the kinect fusion algorithm.
* The raw depth map is first blured, eventually truncated, and downsampled for each pyramid level.
* The raw depth map is first blurred, eventually truncated, and downsampled for each pyramid level.
* Then, vertex and normal maps are computed for each pyramid level.
* \param[in] depth_raw the raw depth map to process
* \param[in] cam_intrinsics intrinsics of the camera used to acquire the depth map
Expand Down
2 changes: 1 addition & 1 deletion gpu/kinfu_large_scale/src/internal.h
Original file line number Diff line number Diff line change
Expand Up @@ -357,7 +357,7 @@ namespace pcl
PCL_EXPORTS size_t
extractSliceAsCloud (const PtrStep<short2>& volume, const float3& volume_size, const pcl::gpu::kinfuLS::tsdf_buffer* buffer, const int shiftX, const int shiftY, const int shiftZ, PtrSz<PointType> output_xyz, PtrSz<float> output_intensities);

/** \brief Performs normals computation for given poins using tsdf volume
/** \brief Performs normals computation for given points using tsdf volume
* \param[in] volume tsdf volume
* \param[in] volume_size volume size
* \param[in] input points where normals are computed
Expand Down
2 changes: 1 addition & 1 deletion gpu/kinfu_large_scale/tools/record_tsdfvolume.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -373,7 +373,7 @@ main (int argc, char* argv[])
// parse input cloud file
pc::parse_argument (argc, argv, "-cf", cloud_file);

// pase output volume file
// parse output volume file
pc::parse_argument (argc, argv, "-vf", volume_file);

// parse options to extract and save cloud from volume
Expand Down
4 changes: 2 additions & 2 deletions gpu/kinfu_large_scale/tools/standalone_texture_mapping.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -239,7 +239,7 @@ saveOBJFile (const std::string &file_name,
PCL_INFO ("Closing obj file\n");
fs.close ();

/* Write material defination for OBJ file*/
/* Write material definition for OBJ file*/
// Open file
PCL_INFO ("Writing material files\n");
//don't do it if no material to write
Expand Down Expand Up @@ -363,7 +363,7 @@ std::ifstream& GotoLine(std::ifstream& file, unsigned int num)
return (file);
}

/** \brief Helper function that reads a camera file outputed by Kinfu */
/** \brief Helper function that reads a camera file outputted by Kinfu */
bool readCamPoseFile(std::string filename, pcl::TextureMapping<pcl::PointXYZ>::Camera &cam)
{
ifstream myReadFile;
Expand Down
2 changes: 1 addition & 1 deletion gpu/octree/test/test_host_radius_search.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -110,7 +110,7 @@ TEST(PCL_OctreeGPU, hostRadiusSearch)

for(size_t i = 0; i < data.tests_num; ++i)
{
//search host on octree tha was built on device
//search host on octree that was built on device
vector<int> results_host_gpu; //host search
octree_device.radiusSearchHost(data.queries[i], data.radiuses[i], results_host_gpu);

Expand Down
2 changes: 1 addition & 1 deletion io/include/pcl/io/hdl_grabber.h
Original file line number Diff line number Diff line change
Expand Up @@ -118,7 +118,7 @@ namespace pcl
HDLGrabber (const std::string& correctionsFile = "",
const std::string& pcapFile = "");

/** \brief Constructor taking a pecified IP/port and an optional path to an HDL corrections file.
/** \brief Constructor taking a specified IP/port and an optional path to an HDL corrections file.
* \param[in] ipAddress IP Address that should be used to listen for HDL packets
* \param[in] port UDP Port that should be used to listen for HDL packets
* \param[in] correctionsFile Path to a file which contains the correction parameters for the HDL. This field is mandatory for the HDL-64, optional for the HDL-32
Expand Down
2 changes: 1 addition & 1 deletion io/include/pcl/io/openni2/openni2_device_manager.h
Original file line number Diff line number Diff line change
Expand Up @@ -59,7 +59,7 @@ namespace pcl
OpenNI2DeviceManager ();
virtual ~OpenNI2DeviceManager ();

// This may not actually be a sigleton yet. Need to work out cross-dll incerface.
// This may not actually be a singleton yet. Need to work out cross-dll incerface.
// Based on http://stackoverflow.com/a/13431981/1789618
static boost::shared_ptr<OpenNI2DeviceManager> getInstance ()
{
Expand Down
2 changes: 1 addition & 1 deletion io/include/pcl/io/png_io.h
Original file line number Diff line number Diff line change
Expand Up @@ -100,7 +100,7 @@ namespace pcl
PCL_EXPORTS void
savePNGFile (const std::string& file_name, const pcl::PointCloud<unsigned short>& cloud);

/** \brief Saves a PCLImage (formely ROS sensor_msgs::Image) to PNG file.
/** \brief Saves a PCLImage (formerly ROS sensor_msgs::Image) to PNG file.
* \param[in] file_name the name of the file to write to disk
* \param[in] image image to save
* \ingroup io
Expand Down
2 changes: 1 addition & 1 deletion io/include/pcl/io/vtk_io.h
Original file line number Diff line number Diff line change
Expand Up @@ -45,7 +45,7 @@
#include <pcl/PCLPointCloud2.h>
#include <pcl/PolygonMesh.h>

// Please do not add any functions tha depend on VTK structures to this file!
// Please do not add any functions that depend on VTK structures to this file!
// Use vtk_io_lib.h instead.

namespace pcl
Expand Down
2 changes: 1 addition & 1 deletion io/src/dinast_grabber.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -313,7 +313,7 @@ pcl::DinastGrabber::getXYZIPointCloud ()
{
double pixel = image_[x + image_width_ * y];

// Correcting distortion, data emprically got in a calibration test
// Correcting distortion, data empirically got in a calibration test
double xc = static_cast<double> (x - image_width_ / 2);
double yc = static_cast<double> (y - image_height_ / 2);
double r1 = sqrt (xc * xc + yc * yc);
Expand Down
Loading

0 comments on commit a63431b

Please sign in to comment.