Welcome to mirror list, hosted at ThFree Co, Russian Federation.

git.blender.org/blender.git - Unnamed repository; edit this file 'description' to name the repository.
summaryrefslogtreecommitdiff
diff options
context:
space:
mode:
authorCampbell Barton <ideasman42@gmail.com>2012-10-21 00:20:02 +0400
committerCampbell Barton <ideasman42@gmail.com>2012-10-21 00:20:02 +0400
commitc56a911cd966d4103b2c13903548dfe97b04742b (patch)
treedefc49c9fbc7371b892bc7d7bc9a27aa9227b984 /source/blender/blenlib
parent80d3423b00583195c94d24aacfa7d841f6a581f7 (diff)
style cleanup: comments
Diffstat (limited to 'source/blender/blenlib')
-rw-r--r--source/blender/blenlib/intern/BLI_kdopbvh.c46
-rw-r--r--source/blender/blenlib/intern/DLRB_tree.c2
-rw-r--r--source/blender/blenlib/intern/freetypefont.c8
-rw-r--r--source/blender/blenlib/intern/math_geom.c38
-rw-r--r--source/blender/blenlib/intern/math_matrix.c78
-rw-r--r--source/blender/blenlib/intern/math_rotation.c8
-rw-r--r--source/blender/blenlib/intern/path_util.c2
-rw-r--r--source/blender/blenlib/intern/storage.c6
8 files changed, 94 insertions, 94 deletions
diff --git a/source/blender/blenlib/intern/BLI_kdopbvh.c b/source/blender/blenlib/intern/BLI_kdopbvh.c
index 46b0cfeaaac..9fbbd7d498d 100644
--- a/source/blender/blenlib/intern/BLI_kdopbvh.c
+++ b/source/blender/blenlib/intern/BLI_kdopbvh.c
@@ -269,7 +269,7 @@ static void bvh_heapsort(BVHNode **a, int lo, int hi, int axis)
}
#endif
-static BVHNode *bvh_medianof3(BVHNode **a, int lo, int mid, int hi, int axis) // returns Sortable
+static BVHNode *bvh_medianof3(BVHNode **a, int lo, int mid, int hi, int axis) /* returns Sortable */
{
if ((a[mid])->bv[axis] < (a[lo])->bv[axis]) {
if ((a[hi])->bv[axis] < (a[mid])->bv[axis])
@@ -645,7 +645,7 @@ static int implicit_leafs_index(BVHBuildHelper *data, int depth, int child_index
* (looping elements, knowing if its a leaf or not.. etc...)
*/
-// This functions returns the number of branches needed to have the requested number of leafs.
+/* This functions returns the number of branches needed to have the requested number of leafs. */
static int implicit_needed_branches(int tree_type, int leafs)
{
return maxi(1, (leafs + tree_type - 3) / (tree_type - 1) );
@@ -843,7 +843,7 @@ BVHTree *BLI_bvhtree_new(int maxsize, float epsilon, char tree_type, char axis)
}
- //Allocate arrays
+ /* Allocate arrays */
numnodes = maxsize + implicit_needed_branches(tree_type, maxsize) + tree_type;
tree->nodes = (BVHNode **)MEM_callocN(sizeof(BVHNode *) * numnodes, "BVHNodes");
@@ -876,7 +876,7 @@ BVHTree *BLI_bvhtree_new(int maxsize, float epsilon, char tree_type, char axis)
return NULL;
}
- //link the dynamic bv and child links
+ /* link the dynamic bv and child links */
for (i = 0; i < numnodes; i++) {
tree->nodearray[i].bv = tree->nodebv + i * axis;
tree->nodearray[i].children = tree->nodechild + i * tree_type;
@@ -968,10 +968,10 @@ int BLI_bvhtree_update_node(BVHTree *tree, int index, const float co[3], const f
if (co_moving)
create_kdop_hull(tree, node, co_moving, numpoints, 1);
- // inflate the bv with some epsilon
+ /* inflate the bv with some epsilon */
for (i = tree->start_axis; i < tree->stop_axis; i++) {
- node->bv[(2 * i)] -= tree->epsilon; // minimum
- node->bv[(2 * i) + 1] += tree->epsilon; // maximum
+ node->bv[(2 * i)] -= tree->epsilon; /* minimum */
+ node->bv[(2 * i) + 1] += tree->epsilon; /* maximum */
}
return 1;
@@ -1045,7 +1045,7 @@ static void traverse(BVHOverlapData *data, BVHNode *node1, BVHNode *node2)
data->max_overlap *= 2;
}
- // both leafs, insert overlap!
+ /* both leafs, insert overlap! */
data->overlap[data->i].indexA = node1->index;
data->overlap[data->i].indexB = node2->index;
@@ -1075,11 +1075,11 @@ BVHTreeOverlap *BLI_bvhtree_overlap(BVHTree *tree1, BVHTree *tree2, unsigned int
BVHTreeOverlap *overlap = NULL, *to = NULL;
BVHOverlapData **data;
- // check for compatibility of both trees (can't compare 14-DOP with 18-DOP)
+ /* check for compatibility of both trees (can't compare 14-DOP with 18-DOP) */
if ((tree1->axis != tree2->axis) && (tree1->axis == 14 || tree2->axis == 14) && (tree1->axis == 18 || tree2->axis == 18))
return NULL;
- // fast check root nodes for collision before doing big splitting + traversal
+ /* fast check root nodes for collision before doing big splitting + traversal */
if (!tree_overlap(tree1->nodes[tree1->totleaf], tree2->nodes[tree2->totleaf], MIN2(tree1->start_axis, tree2->start_axis), MIN2(tree1->stop_axis, tree2->stop_axis)))
return NULL;
@@ -1088,7 +1088,7 @@ BVHTreeOverlap *BLI_bvhtree_overlap(BVHTree *tree1, BVHTree *tree2, unsigned int
for (j = 0; j < tree1->tree_type; j++) {
data[j] = (BVHOverlapData *)MEM_callocN(sizeof(BVHOverlapData), "BVHOverlapData");
- // init BVHOverlapData
+ /* init BVHOverlapData */
data[j]->overlap = (BVHTreeOverlap *)malloc(sizeof(BVHTreeOverlap) * MAX2(tree1->totleaf, tree2->totleaf));
data[j]->tree1 = tree1;
data[j]->tree2 = tree2;
@@ -1123,13 +1123,13 @@ BVHTreeOverlap *BLI_bvhtree_overlap(BVHTree *tree1, BVHTree *tree2, unsigned int
return overlap;
}
-//Determines the nearest point of the given node BV. Returns the squared distance to that point.
+/* Determines the nearest point of the given node BV. Returns the squared distance to that point. */
static float calc_nearest_point(const float proj[3], BVHNode *node, float *nearest)
{
int i;
const float *bv = node->bv;
- //nearest on AABB hull
+ /* nearest on AABB hull */
for (i = 0; i != 3; i++, bv += 2) {
if (bv[0] > proj[i])
nearest[i] = bv[0];
@@ -1140,7 +1140,7 @@ static float calc_nearest_point(const float proj[3], BVHNode *node, float *neare
}
#if 0
- //nearest on a general hull
+ /* nearest on a general hull */
copy_v3_v3(nearest, data->co);
for (i = data->tree->start_axis; i != data->tree->stop_axis; i++, bv += 2)
{
@@ -1167,7 +1167,7 @@ typedef struct NodeDistance {
} NodeDistance;
-// TODO: use a priority queue to reduce the number of nodes looked on
+/* TODO: use a priority queue to reduce the number of nodes looked on */
static void dfs_find_nearest_dfs(BVHNearestData *data, BVHNode *node)
{
if (node->totnode == 0) {
@@ -1179,7 +1179,7 @@ static void dfs_find_nearest_dfs(BVHNearestData *data, BVHNode *node)
}
}
else {
- //Better heuristic to pick the closest node to dive on
+ /* Better heuristic to pick the closest node to dive on */
int i;
float nearest[3];
@@ -1259,7 +1259,7 @@ static void bfs_find_nearest(BVHNearestData *data, BVHNode *node)
dfs_find_nearest_dfs(data, child);
}
else {
- //adjust heap size
+ /* adjust heap size */
if ((heap_size >= max_heap_size) &&
ADJUST_MEMORY(default_heap, (void **)&heap, heap_size + 1, &max_heap_size, sizeof(heap[0])) == FALSE)
{
@@ -1306,7 +1306,7 @@ int BLI_bvhtree_find_nearest(BVHTree *tree, const float co[3], BVHTreeNearest *n
BVHNearestData data;
BVHNode *root = tree->nodes[tree->totleaf];
- //init data to search
+ /* init data to search */
data.tree = tree;
data.co = co;
@@ -1354,7 +1354,7 @@ static float ray_nearest_hit(BVHRayCastData *data, const float bv[6])
for (i = 0; i != 3; i++, bv += 2) {
if (data->ray_dot_axis[i] == 0.0f) {
- //axis aligned ray
+ /* axis aligned ray */
if (data->ray.origin[i] < bv[0] - data->ray.radius ||
data->ray.origin[i] > bv[1] + data->ray.radius)
{
@@ -1531,7 +1531,7 @@ float BLI_bvhtree_bb_raycast(const float bv[6], const float light_start[3], cons
data.hit.dist = FLT_MAX;
- // get light direction
+ /* get light direction */
data.ray.direction[0] = light_end[0] - light_start[0];
data.ray.direction[1] = light_end[1] - light_start[1];
data.ray.direction[2] = light_end[2] - light_start[2];
@@ -1563,7 +1563,7 @@ float BLI_bvhtree_bb_raycast(const float bv[6], const float light_start[3], cons
typedef struct RangeQueryData {
BVHTree *tree;
const float *center;
- float radius; //squared radius
+ float radius; /* squared radius */
int hits;
@@ -1578,7 +1578,7 @@ static void dfs_range_query(RangeQueryData *data, BVHNode *node)
{
if (node->totnode == 0) {
#if 0 /*UNUSED*/
- //Calculate the node min-coords (if the node was a point then this is the point coordinates)
+ /* Calculate the node min-coords (if the node was a point then this is the point coordinates) */
float co[3];
co[0] = node->bv[0];
co[1] = node->bv[2];
@@ -1591,7 +1591,7 @@ static void dfs_range_query(RangeQueryData *data, BVHNode *node)
float nearest[3];
float dist = calc_nearest_point(data->center, node->children[i], nearest);
if (dist < data->radius) {
- //Its a leaf.. call the callback
+ /* Its a leaf.. call the callback */
if (node->children[i]->totnode == 0) {
data->hits++;
data->callback(data->userdata, node->children[i]->index, dist);
diff --git a/source/blender/blenlib/intern/DLRB_tree.c b/source/blender/blenlib/intern/DLRB_tree.c
index 858eef0b2df..688372b3a28 100644
--- a/source/blender/blenlib/intern/DLRB_tree.c
+++ b/source/blender/blenlib/intern/DLRB_tree.c
@@ -502,7 +502,7 @@ void BLI_dlrbTree_insert(DLRBT_Tree *tree, DLRBT_Node *node)
/* ----- */
/* Add the given data to the tree, and return the node added */
-// NOTE: for duplicates, the update_cb is called (if available), and the existing node is returned
+/* NOTE: for duplicates, the update_cb is called (if available), and the existing node is returned */
DLRBT_Node *BLI_dlrbTree_add(DLRBT_Tree *tree, DLRBT_Comparator_FP cmp_cb,
DLRBT_NAlloc_FP new_cb, DLRBT_NUpdate_FP update_cb, void *data)
{
diff --git a/source/blender/blenlib/intern/freetypefont.c b/source/blender/blenlib/intern/freetypefont.c
index 51e4ab0f47a..4ccfb625241 100644
--- a/source/blender/blenlib/intern/freetypefont.c
+++ b/source/blender/blenlib/intern/freetypefont.c
@@ -473,10 +473,10 @@ VFontData *BLI_vfontdata_from_freetypefont(PackedFile *pf)
VFontData *vfd = NULL;
int success = 0;
- //init Freetype
+ /* init Freetype */
err = FT_Init_FreeType(&library);
if (err) {
- //XXX error("Failed to load the Freetype font library");
+ /* XXX error("Failed to load the Freetype font library"); */
return NULL;
}
@@ -486,7 +486,7 @@ VFontData *BLI_vfontdata_from_freetypefont(PackedFile *pf)
vfd = objfnt_to_ftvfontdata(pf);
}
- //free Freetype
+ /* free Freetype */
FT_Done_FreeType(library);
return vfd;
@@ -518,7 +518,7 @@ int BLI_vfontchar_from_freetypefont(VFont *vfont, unsigned long character)
#if 0
-// Freetype2 Outline struct
+/* Freetype2 Outline struct */
typedef struct FT_Outline_
{
diff --git a/source/blender/blenlib/intern/math_geom.c b/source/blender/blenlib/intern/math_geom.c
index 50cef039acf..122fc8e9f4a 100644
--- a/source/blender/blenlib/intern/math_geom.c
+++ b/source/blender/blenlib/intern/math_geom.c
@@ -939,10 +939,10 @@ void isect_plane_plane_v3(float r_isect_co[3], float r_isect_no[3],
/* "Improved Collision detection and Response" */
static int getLowestRoot(const float a, const float b, const float c, const float maxR, float *root)
{
- // Check if a solution exists
+ /* Check if a solution exists */
float determinant = b * b - 4.0f * a * c;
- // If determinant is negative it means no solutions.
+ /* If determinant is negative it means no solutions. */
if (determinant >= 0.0f) {
/* calculate the two roots: (if determinant == 0 then
* x1==x2 but lets disregard that slight optimization) */
@@ -950,24 +950,24 @@ static int getLowestRoot(const float a, const float b, const float c, const floa
float r1 = (-b - sqrtD) / (2.0f * a);
float r2 = (-b + sqrtD) / (2.0f * a);
- // Sort so x1 <= x2
+ /* Sort so x1 <= x2 */
if (r1 > r2)
SWAP(float, r1, r2);
- // Get lowest root:
+ /* Get lowest root: */
if (r1 > 0.0f && r1 < maxR) {
*root = r1;
return 1;
}
- // It is possible that we want x2 - this can happen
- // if x1 < 0
+ /* It is possible that we want x2 - this can happen */
+ /* if x1 < 0 */
if (r2 > 0.0f && r2 < maxR) {
*root = r2;
return 1;
}
}
- // No (valid) solutions
+ /* No (valid) solutions */
return 0;
}
@@ -1080,7 +1080,7 @@ int isect_sweeping_sphere_tri_v3(const float p1[3], const float p2[3], const flo
}
/*---test edges---*/
- sub_v3_v3v3(e3, v2, v1); //wasnt yet calculated
+ sub_v3_v3v3(e3, v2, v1); /* wasnt yet calculated */
/*e1*/
@@ -1344,7 +1344,7 @@ void isect_ray_aabb_initialize(IsectRayAABBData *data, const float ray_start[3],
/* Adapted from http://www.gamedev.net/community/forums/topic.asp?topic_id=459973 */
int isect_ray_aabb(const IsectRayAABBData *data, const float bb_min[3],
- const float bb_max[3], float *tmin_out)
+ const float bb_max[3], float *tmin_out)
{
float bbox[2][3];
float tmin, tmax, tymin, tymax, tzmin, tzmax;
@@ -1587,7 +1587,7 @@ void isect_point_face_uv_v2(const int isquad,
}
}
-#if 0 // XXX this version used to be used in isect_point_tri_v2_int() and was called IsPointInTri2D
+#if 0 /* XXX this version used to be used in isect_point_tri_v2_int() and was called IsPointInTri2D */
int isect_point_tri_v2(float pt[2], float v1[2], float v2[2], float v3[2])
{
@@ -1777,7 +1777,7 @@ void plot_line_v2v2i(const int p1[2], const int p2[2], int (*callback)(int, int,
signed char ix;
signed char iy;
- // if x1 == x2 or y1 == y2, then it does not matter what we set here
+ /* if x1 == x2 or y1 == y2, then it does not matter what we set here */
int delta_x = (x2 > x1 ? (ix = 1, x2 - x1) : (ix = -1, x1 - x2)) << 1;
int delta_y = (y2 > y1 ? (iy = 1, y2 - y1) : (iy = -1, y1 - y2)) << 1;
@@ -1786,7 +1786,7 @@ void plot_line_v2v2i(const int p1[2], const int p2[2], int (*callback)(int, int,
}
if (delta_x >= delta_y) {
- // error may go below zero
+ /* error may go below zero */
int error = delta_y - (delta_x >> 1);
while (x1 != x2) {
@@ -1795,9 +1795,9 @@ void plot_line_v2v2i(const int p1[2], const int p2[2], int (*callback)(int, int,
y1 += iy;
error -= delta_x;
}
- // else do nothing
+ /* else do nothing */
}
- // else do nothing
+ /* else do nothing */
x1 += ix;
error += delta_y;
@@ -1808,7 +1808,7 @@ void plot_line_v2v2i(const int p1[2], const int p2[2], int (*callback)(int, int,
}
}
else {
- // error may go below zero
+ /* error may go below zero */
int error = delta_x - (delta_y >> 1);
while (y1 != y2) {
@@ -1817,9 +1817,9 @@ void plot_line_v2v2i(const int p1[2], const int p2[2], int (*callback)(int, int,
x1 += ix;
error -= delta_y;
}
- // else do nothing
+ /* else do nothing */
}
- // else do nothing
+ /* else do nothing */
y1 += iy;
error += delta_x;
@@ -2334,7 +2334,7 @@ void resolve_quad_uv(float r_uv[2], const float st[2], const float st0[2], const
const double fC = (st1[0] - st[0]) * (st1[1] - st2[1]) - (st1[1] - st[1]) * (st1[0] - st2[0]);
const double denom = a - 2 * b + fC;
- // clear outputs
+ /* clear outputs */
zero_v2(r_uv);
if (IS_ZERO(denom) != 0) {
@@ -2650,7 +2650,7 @@ void accumulate_vertex_normals(float n1[3], float n2[3], float n3[3],
const float *cur_edge = vdiffs[i];
const float fac = saacos(-dot_v3v3(cur_edge, prev_edge));
- // accumulate
+ /* accumulate */
madd_v3_v3fl(vn[i], f_no, fac);
prev_edge = cur_edge;
}
diff --git a/source/blender/blenlib/intern/math_matrix.c b/source/blender/blenlib/intern/math_matrix.c
index 1f61b37a1af..3e19ea4f999 100644
--- a/source/blender/blenlib/intern/math_matrix.c
+++ b/source/blender/blenlib/intern/math_matrix.c
@@ -1408,8 +1408,8 @@ void svd_m4(float U[4][4], float s[4], float V[4][4], float A_[4][4])
int i = 0, j = 0, k = 0, p, pp, iter;
- // Reduce A to bidiagonal form, storing the diagonal elements
- // in s and the super-diagonal elements in e.
+ /* Reduce A to bidiagonal form, storing the diagonal elements
+ * in s and the super-diagonal elements in e. */
int nct = minf(m - 1, n);
int nrt = maxf(0, minf(n - 2, m));
@@ -1421,9 +1421,9 @@ void svd_m4(float U[4][4], float s[4], float V[4][4], float A_[4][4])
for (k = 0; k < maxf(nct, nrt); k++) {
if (k < nct) {
- // Compute the transformation for the k-th column and
- // place the k-th diagonal in s[k].
- // Compute 2-norm of k-th column without under/overflow.
+ /* Compute the transformation for the k-th column and
+ * place the k-th diagonal in s[k].
+ * Compute 2-norm of k-th column without under/overflow. */
s[k] = 0;
for (i = k; i < m; i++) {
s[k] = hypotf(s[k], A[i][k]);
@@ -1444,7 +1444,7 @@ void svd_m4(float U[4][4], float s[4], float V[4][4], float A_[4][4])
for (j = k + 1; j < n; j++) {
if ((k < nct) && (s[k] != 0.0f)) {
- // Apply the transformation.
+ /* Apply the transformation. */
float t = 0;
for (i = k; i < m; i++) {
@@ -1456,24 +1456,24 @@ void svd_m4(float U[4][4], float s[4], float V[4][4], float A_[4][4])
}
}
- // Place the k-th row of A into e for the
- // subsequent calculation of the row transformation.
+ /* Place the k-th row of A into e for the */
+ /* subsequent calculation of the row transformation. */
e[j] = A[k][j];
}
if (k < nct) {
- // Place the transformation in U for subsequent back
- // multiplication.
+ /* Place the transformation in U for subsequent back
+ * multiplication. */
for (i = k; i < m; i++)
U[i][k] = A[i][k];
}
if (k < nrt) {
- // Compute the k-th row transformation and place the
- // k-th super-diagonal in e[k].
- // Compute 2-norm without under/overflow.
+ /* Compute the k-th row transformation and place the
+ * k-th super-diagonal in e[k].
+ * Compute 2-norm without under/overflow. */
e[k] = 0;
for (i = k + 1; i < n; i++) {
e[k] = hypotf(e[k], e[i]);
@@ -1493,7 +1493,7 @@ void svd_m4(float U[4][4], float s[4], float V[4][4], float A_[4][4])
if ((k + 1 < m) & (e[k] != 0.0f)) {
float invek1;
- // Apply the transformation.
+ /* Apply the transformation. */
for (i = k + 1; i < m; i++) {
work[i] = 0.0f;
@@ -1512,15 +1512,15 @@ void svd_m4(float U[4][4], float s[4], float V[4][4], float A_[4][4])
}
}
- // Place the transformation in V for subsequent
- // back multiplication.
+ /* Place the transformation in V for subsequent
+ * back multiplication. */
for (i = k + 1; i < n; i++)
V[i][k] = e[i];
}
}
- // Set up the final bidiagonal matrix or order p.
+ /* Set up the final bidiagonal matrix or order p. */
p = minf(n, m + 1);
if (nct < n) {
@@ -1534,7 +1534,7 @@ void svd_m4(float U[4][4], float s[4], float V[4][4], float A_[4][4])
}
e[p - 1] = 0.0f;
- // If required, generate U.
+ /* If required, generate U. */
for (j = nct; j < nu; j++) {
for (i = 0; i < m; i++) {
@@ -1570,7 +1570,7 @@ void svd_m4(float U[4][4], float s[4], float V[4][4], float A_[4][4])
}
}
- // If required, generate V.
+ /* If required, generate V. */
for (k = n - 1; k >= 0; k--) {
if ((k < nrt) & (e[k] != 0.0f)) {
@@ -1591,7 +1591,7 @@ void svd_m4(float U[4][4], float s[4], float V[4][4], float A_[4][4])
V[k][k] = 1.0f;
}
- // Main iteration loop for the singular values.
+ /* Main iteration loop for the singular values. */
pp = p - 1;
iter = 0;
@@ -1599,20 +1599,20 @@ void svd_m4(float U[4][4], float s[4], float V[4][4], float A_[4][4])
while (p > 0) {
int kase = 0;
- // Test for maximum iterations to avoid infinite loop
+ /* Test for maximum iterations to avoid infinite loop */
if (maxiter == 0)
break;
maxiter--;
- // This section of the program inspects for
- // negligible elements in the s and e arrays. On
- // completion the variables kase and k are set as follows.
-
- // kase = 1 if s(p) and e[k - 1] are negligible and k<p
- // kase = 2 if s(k) is negligible and k<p
- // kase = 3 if e[k - 1] is negligible, k<p, and
- // s(k), ..., s(p) are not negligible (qr step).
- // kase = 4 if e(p - 1) is negligible (convergence).
+ /* This section of the program inspects for
+ * negligible elements in the s and e arrays. On
+ * completion the variables kase and k are set as follows.
+ *
+ * kase = 1 if s(p) and e[k - 1] are negligible and k<p
+ * kase = 2 if s(k) is negligible and k<p
+ * kase = 3 if e[k - 1] is negligible, k<p, and
+ * s(k), ..., s(p) are not negligible (qr step).
+ * kase = 4 if e(p - 1) is negligible (convergence). */
for (k = p - 2; k >= -1; k--) {
if (k == -1) {
@@ -1653,11 +1653,11 @@ void svd_m4(float U[4][4], float s[4], float V[4][4], float A_[4][4])
}
k++;
- // Perform the task indicated by kase.
+ /* Perform the task indicated by kase. */
switch (kase) {
- // Deflate negligible s(p).
+ /* Deflate negligible s(p). */
case 1:
{
@@ -1683,7 +1683,7 @@ void svd_m4(float U[4][4], float s[4], float V[4][4], float A_[4][4])
break;
}
- // Split at negligible s(k).
+ /* Split at negligible s(k). */
case 2:
{
@@ -1707,12 +1707,12 @@ void svd_m4(float U[4][4], float s[4], float V[4][4], float A_[4][4])
break;
}
- // Perform one qr step.
+ /* Perform one qr step. */
case 3:
{
- // Calculate the shift.
+ /* Calculate the shift. */
float scale = maxf(maxf(maxf(maxf(
fabsf(s[p - 1]), fabsf(s[p - 2])), fabsf(e[p - 2])),
@@ -1737,7 +1737,7 @@ void svd_m4(float U[4][4], float s[4], float V[4][4], float A_[4][4])
f = (sk + sp) * (sk - sp) + shift;
g = sk * ek;
- // Chase zeros.
+ /* Chase zeros. */
for (j = k; j < p - 1; j++) {
float t = hypotf(f, g);
@@ -1779,12 +1779,12 @@ void svd_m4(float U[4][4], float s[4], float V[4][4], float A_[4][4])
iter = iter + 1;
break;
}
- // Convergence.
+ /* Convergence. */
case 4:
{
- // Make the singular values positive.
+ /* Make the singular values positive. */
if (s[k] <= 0.0f) {
s[k] = (s[k] < 0.0f ? -s[k] : 0.0f);
@@ -1793,7 +1793,7 @@ void svd_m4(float U[4][4], float s[4], float V[4][4], float A_[4][4])
V[i][k] = -V[i][k];
}
- // Order the singular values.
+ /* Order the singular values. */
while (k < pp) {
float t;
diff --git a/source/blender/blenlib/intern/math_rotation.c b/source/blender/blenlib/intern/math_rotation.c
index 53f2c1cd0d9..ce13a278274 100644
--- a/source/blender/blenlib/intern/math_rotation.c
+++ b/source/blender/blenlib/intern/math_rotation.c
@@ -797,7 +797,7 @@ void mat3_to_axis_angle(float axis[3], float *angle, float mat[3][3])
float q[4];
/* use quaternions as intermediate representation */
- // TODO: it would be nicer to go straight there...
+ /* TODO: it would be nicer to go straight there... */
mat3_to_quat(q, mat);
quat_to_axis_angle(axis, angle, q);
}
@@ -808,7 +808,7 @@ void mat4_to_axis_angle(float axis[3], float *angle, float mat[4][4])
float q[4];
/* use quaternions as intermediate representation */
- // TODO: it would be nicer to go straight there...
+ /* TODO: it would be nicer to go straight there... */
mat4_to_quat(q, mat);
quat_to_axis_angle(axis, angle, q);
}
@@ -1363,7 +1363,7 @@ void mat4_to_compatible_eulO(float eul[3], float oldrot[3], const short order, f
mat3_to_compatible_eulO(eul, oldrot, order, m);
}
/* rotate the given euler by the given angle on the specified axis */
-// NOTE: is this safe to do with different axis orders?
+/* NOTE: is this safe to do with different axis orders? */
void rotate_eulO(float beul[3], const short order, char axis, float ang)
{
@@ -1691,7 +1691,7 @@ void vec_apply_track(float vec[3], short axis)
case 2: /* pos-z */
/* vec[0]= tvec[0]; */
/* vec[1]= tvec[1]; */
- // vec[2]= 0.0; */
+ /* vec[2]= 0.0; */
break;
case 3: /* neg-x */
/* vec[0]= 0.0; */
diff --git a/source/blender/blenlib/intern/path_util.c b/source/blender/blenlib/intern/path_util.c
index cc482e2d3d8..0ae18d6e177 100644
--- a/source/blender/blenlib/intern/path_util.c
+++ b/source/blender/blenlib/intern/path_util.c
@@ -47,7 +47,7 @@
#include "BLI_string_utf8.h"
#include "BLI_utildefines.h"
-#include "BKE_blender.h" // BLENDER_VERSION
+#include "BKE_blender.h" /* BLENDER_VERSION */
#include "GHOST_Path-api.h"
diff --git a/source/blender/blenlib/intern/storage.c b/source/blender/blenlib/intern/storage.c
index 0d3f6aee30f..dec04939724 100644
--- a/source/blender/blenlib/intern/storage.c
+++ b/source/blender/blenlib/intern/storage.c
@@ -418,9 +418,9 @@ static void bli_adddirstrings(void)
unsigned int BLI_dir_contents(const char *dirname, struct direntry **filelist)
{
- // reset global variables
- // memory stored in files is free()'d in
- // filesel.c:freefilelist()
+ /* reset global variables
+ * memory stored in files is free()'d in
+ * filesel.c:freefilelist() */
actnum = totnum = 0;
files = NULL;