]> granicus.if.org Git - graphviz/commitdiff
remove unnecessary bracketing
authorMatthew Fernandez <matthew.fernandez@gmail.com>
Sun, 18 Apr 2021 05:02:20 +0000 (22:02 -0700)
committerMatthew Fernandez <matthew.fernandez@gmail.com>
Sat, 24 Apr 2021 20:31:57 +0000 (13:31 -0700)
lib/neatogen/heap.c
lib/neatogen/info.c
lib/neatogen/legal.c
lib/neatogen/neatoinit.c
lib/neatogen/voronoi.c

index 48ea43d0aec8e86086f37c526f2380e5e922a354..4a8926ff4ebf74a73b83f8ce0a35aace58a9829c 100644 (file)
@@ -36,7 +36,7 @@ static int PQbucket(Halfedge * he)
        bucket = b;
     if (bucket < PQmin)
        PQmin = bucket;
-    return (bucket);
+    return bucket;
 }
 
 void PQinsert(Halfedge * he, Site * v, double offset)
@@ -76,7 +76,7 @@ void PQdelete(Halfedge * he)
 
 int PQempty(void)
 {
-    return (PQcount == 0);
+    return PQcount == 0;
 }
 
 
@@ -89,7 +89,7 @@ Point PQ_min(void)
     }
     answer.x = PQhash[PQmin].PQnext->vertex->coord.x;
     answer.y = PQhash[PQmin].PQnext->ystar;
-    return (answer);
+    return answer;
 }
 
 Halfedge *PQextractmin(void)
@@ -99,7 +99,7 @@ Halfedge *PQextractmin(void)
     curr = PQhash[PQmin].PQnext;
     PQhash[PQmin].PQnext = curr->PQnext;
     PQcount -= 1;
-    return (curr);
+    return curr;
 }
 
 void PQcleanup(void)
@@ -125,7 +125,7 @@ static void PQdumphe(Halfedge * p)
 {
     printf("  [%p] %p %p %d %d %d %d %f\n",
           p, p->ELleft, p->ELright, p->ELedge->edgenbr,
-          p->ELrefcnt, p->ELpm, (p->vertex ? p->vertex->sitenbr : -1),
+          p->ELrefcnt, p->ELpm, p->vertex ? p->vertex->sitenbr : -1,
           p->ystar);
 }
 
index e8d8d4de1640433685124e350161815c5615d06f..ec508bb1bb6288862702b152abdcc81ae7916fc1 100644 (file)
@@ -41,13 +41,13 @@ static int compare(Point * o, PtItem * p, PtItem * q)
 
     if (q == NULL)
        return -1;
-    if ((p->p.x == q->p.x) && (p->p.y == q->p.y))
+    if (p->p.x == q->p.x && p->p.y == q->p.y)
        return 0;
 
-    x0 = ((double) (p->p.x)) - ((double) (o->x));
-    y0 = ((double) (p->p.y)) - ((double) (o->y));
-    x1 = ((double) (q->p.x)) - ((double) (o->x));
-    y1 = ((double) (q->p.y)) - ((double) (o->y));
+    x0 = (double)p->p.x - (double)o->x;
+    y0 = (double)p->p.y - (double)o->y;
+    x1 = (double)q->p.x - (double)o->x;
+    y1 = (double)q->p.y - (double)o->y;
     if (x0 >= 0.0) {
        if (x1 < 0.0)
            return -1;
@@ -113,11 +113,11 @@ void addVertex(Site * s, double x, double y)
     PtItem *p;
     PtItem *curr;
     PtItem *prev;
-    Point *origin = &(s->coord);
+    Point *origin = &s->coord;
     PtItem tmp;
     int cmp;
 
-    ip = nodeInfo + (s->sitenbr);
+    ip = nodeInfo + s->sitenbr;
     curr = ip->verts;
 
     tmp.p.x = x;
index acb5efeeccbf97eff857750e29d349f5ecdb6e66..a090cfaa70b643aef7dd70bea365c13877a83577 100644 (file)
@@ -71,19 +71,19 @@ static void sgnarea(vertex *l, vertex *m, int i[])
     f = m->pos.y - b;
     g = after(m)->pos.x - a;
     h = after(m)->pos.y - b;
-    t = (c * f) - (d * e);
-    i[0] = ((t == 0) ? 0 : (t > 0 ? 1 : -1));
-    t = (c * h) - (d * g);
-    i[1] = ((t == 0) ? 0 : (t > 0 ? 1 : -1));
+    t = c * f - d * e;
+    i[0] = t == 0 ? 0 : (t > 0 ? 1 : -1);
+    t = c * h - d * g;
+    i[1] = t == 0 ? 0 : (t > 0 ? 1 : -1);
     i[2] = i[0] * i[1];
 }
 
 /* determine if g lies between f and h      */
 static int between(double f, double g, double h)
 {
-    if ((f == g) || (g == h))
-       return (0);
-    return ((f < g) ? (g < h ? 1 : -1) : (h < g ? 1 : -1));
+    if (f == g || g == h)
+       return 0;
+    return f < g ? (g < h ? 1 : -1) : (h < g ? 1 : -1);
 }
 
 /* determine if vertex i of line m is on line l     */
@@ -92,12 +92,10 @@ static int online(vertex *l, vertex *m, int i)
     pointf a, b, c;
     a = l->pos;
     b = after(l)->pos;
-    c = (i == 0) ? m->pos : after(m)->pos;
-    return ((a.x == b.x) ? ((a.x == c.x)
-                           && (-1 !=
-                               between(a.y, c.y, b.y))) : between(a.x,
-                                                                  c.x,
-                                                                  b.x));
+    c = i == 0 ? m->pos : after(m)->pos;
+    return a.x == b.x
+      ? (a.x == c.x && -1 != between(a.y, c.y, b.y))
+      : between(a.x, c.x, b.x);
 }
 
 /* determine point of detected intersections  */
@@ -107,7 +105,7 @@ static int intpoint(vertex *l, vertex *m, double *x, double *y, int cond)
     double m1, m2, c1, c2;
 
     if (cond <= 0)
-       return (0);
+       return 0;
     ls = l->pos;
     le = after(l)->pos;
     ms = m->pos;
@@ -125,24 +123,22 @@ static int intpoint(vertex *l, vertex *m, double *x, double *y, int cond)
        } else {
            m1 = SLOPE(ms, me);
            m2 = SLOPE(ls, le);
-           c1 = ms.y - (m1 * ms.x);
-           c2 = ls.y - (m2 * ls.x);
+           c1 = ms.y - m1 * ms.x;
+           c2 = ls.y - m2 * ls.x;
            *x = (c2 - c1) / (m1 - m2);
-           *y = ((m1 * c2) - (c1 * m2)) / (m1 - m2);
+           *y = (m1 * c2 - c1 * m2) / (m1 - m2);
        }
        break;
 
     case 2:                    /*     the two lines  have a common segment  */
        if (online(l, m, 0) == -1) {    /* ms between ls and le */
            pt1 = ms;
-           pt2 =
-               (online(m, l, 1) ==
-                -1) ? ((online(m, l, 0) == -1) ? le : ls) : me;
+           pt2 = online(m, l, 1) == -1
+             ? (online(m, l, 0) == -1 ? le : ls) : me;
        } else if (online(l, m, 1) == -1) {     /* me between ls and le */
            pt1 = me;
-           pt2 =
-               (online(l, m, 0) ==
-                -1) ? ((online(m, l, 0) == -1) ? le : ls) : ms;
+           pt2 = online(l, m, 0) == -1
+             ? (online(m, l, 0) == -1 ? le : ls) : ms;
        } else {
            /* may be degenerate? */
            if (online(m, l, 0) != -1)
@@ -164,7 +160,7 @@ static int intpoint(vertex *l, vertex *m, double *x, double *y, int cond)
            *y = me.y;
        }
     }                          /* end switch  */
-    return (1);
+    return 1;
 }
 
 static void
@@ -187,12 +183,9 @@ realIntersect (vertex *firstv, vertex *secondv, pointf p)
     vsd = secondv->pos;
     avsd = after(secondv)->pos;
 
-    if (((vft.x != avft.x) && (vsd.x != avsd.x)) ||
-       ((vft.x == avft.x) &&
-        !EQ_PT(vft, p) &&
-        !EQ_PT(avft, p)) ||
-       ((vsd.x == avsd.x) &&
-        !EQ_PT(vsd, p) && !EQ_PT(avsd, p))) 
+    if ((vft.x != avft.x && vsd.x != avsd.x) ||
+       (vft.x == avft.x && !EQ_PT(vft, p) && !EQ_PT(avft, p)) ||
+       (vsd.x == avsd.x && !EQ_PT(vsd, p) && !EQ_PT(avsd, p))) 
     {
        if (Verbose > 1) {
                fprintf(stderr, "\nintersection at %.3f %.3f\n",
@@ -225,12 +218,11 @@ static int find_intersection(vertex *l,
        sgnarea(m, l, i);
        if (i[2] > 0)
            return 0;
-       if (!intpoint
-           (l, m, &x, &y, (i[2] < 0) ? 3 : online(m, l, abs(i[0]))))
+       if (!intpoint(l, m, &x, &y, i[2] < 0 ? 3 : online(m, l, abs(i[0]))))
            return 0;
     }
 
-    else if (!intpoint(l, m, &x, &y, (i[0] == i[1]) ?
+    else if (!intpoint(l, m, &x, &y, i[0] == i[1] ?
                       2 * MAX(online(l, m, 0),
                               online(l, m, 1)) : online(l, m, abs(i[0]))))
        return 0;
@@ -259,11 +251,11 @@ static int gt(vertex **i, vertex **j)
     /* i > j if i.x > j.x or i.x = j.x and i.y > j.y  */
     double t;
     if ((t = (*i)->pos.x - (*j)->pos.x) != 0.)
-       return ((t > 0.) ? 1 : -1);
+       return t > 0. ? 1 : -1;
     if ((t = (*i)->pos.y - (*j)->pos.y) == 0.)
-       return (0);
+       return 0;
     else
-       return ((t > 0.) ? 1 : -1);
+       return t > 0. ? 1 : -1;
 }
 
 /* find_ints:
index 37929f96974a413258ccca39bfe9eadf926c92db..c7e182175aeae6de3f8d4668a4d2b7b6a0d120fa 100644 (file)
@@ -65,8 +65,7 @@ int user_pos(attrsym_t * posptr, attrsym_t * pinptr, node_t * np, int nG)
     p = agxget(np, posptr);
     if (p[0]) {
        c = '\0';
-       if ((Ndim >= 3) &&
-            (sscanf(p, "%lf,%lf,%lf%c", pvec, pvec+1, pvec+2, &c) >= 3)){
+       if (Ndim >= 3 && sscanf(p, "%lf,%lf,%lf%c", pvec, pvec+1, pvec+2, &c) >= 3){
            ND_pinned(np) = P_SET;
            if (PSinputscale > 0.0) {
                int i;
@@ -75,7 +74,7 @@ int user_pos(attrsym_t * posptr, attrsym_t * pinptr, node_t * np, int nG)
            }
            if (Ndim > 3)
                jitter_d(np, nG, 3);
-           if ((c == '!') || (pinptr && mapbool(agxget(np, pinptr))))
+           if (c == '!' || (pinptr && mapbool(agxget(np, pinptr))))
                ND_pinned(np) = P_PIN;
            return TRUE;
        }
@@ -87,7 +86,7 @@ int user_pos(attrsym_t * posptr, attrsym_t * pinptr, node_t * np, int nG)
                    pvec[i] /= PSinputscale;
            }
            if (Ndim > 2) {
-               if (N_z && (p = agxget(np, N_z)) && (sscanf(p,"%lf",&z) == 1)) {
+               if (N_z && (p = agxget(np, N_z)) && sscanf(p,"%lf",&z) == 1) {
                    if (PSinputscale > 0.0) {
                        pvec[2] = z / PSinputscale;
                    }
@@ -98,7 +97,7 @@ int user_pos(attrsym_t * posptr, attrsym_t * pinptr, node_t * np, int nG)
                else
                    jitter3d(np, nG);
            }
-           if ((c == '!') || (pinptr && mapbool(agxget(np, pinptr))))
+           if (c == '!' || (pinptr && mapbool(agxget(np, pinptr))))
                ND_pinned(np) = P_PIN;
            return TRUE;
        } else
@@ -130,7 +129,7 @@ static void neato_init_node_edge(graph_t * g)
 
 static void neato_cleanup_graph(graph_t * g)
 {
-    if (Nop || (Pack < 0)) {
+    if (Nop || Pack < 0) {
        free_scan_graph(g);
        free(GD_clust(g));
     }
@@ -162,7 +161,7 @@ static int numFields(unsigned char *pos)
            pos++;              /* skip white space */
        if ((c = *pos)) { /* skip token */
            cnt++;
-           while ((c = *pos) && !isspace(c) && (c != ';'))
+           while ((c = *pos) && !isspace(c) && c != ';')
                pos++;
        }
     } while (isspace(c));
@@ -174,7 +173,7 @@ static void set_label(void* obj, textlabel_t * l, char *name)
     double x, y;
     char *lp;
     lp = agget(obj, name);
-    if (lp && (sscanf(lp, "%lf,%lf", &x, &y) == 2)) {
+    if (lp && sscanf(lp, "%lf,%lf", &x, &y) == 2) {
        l->pos = pointfof(x, y);
        l->set = TRUE;
     }
@@ -293,7 +292,7 @@ static int user_spline(attrsym_t * E_pos, edge_t * e)
 
        npts = numFields((unsigned char *) pos);        /* count potential points */
        n = npts;
-       if ((n < 4) || (n % 3 != 1)) {
+       if (n < 4 || n % 3 != 1) {
            gv_free_splines(e);
            if (!warned) {
                warned = 1;
@@ -380,7 +379,7 @@ static pos_edge nop_init_edges(Agraph_t * g)
        return AllEdges;
 
     E_pos = agfindedgeattr(g, "pos");
-    if (!E_pos || (Nop < 2))
+    if (!E_pos || Nop < 2)
        return NoEdges;
 
     for (n = agfstnode(g); n; n = agnxtnode(g, n)) {
@@ -559,7 +558,7 @@ int init_nop(Agraph_t * g, int adjust)
     else
        haveBackground = 0;
 
-    if (adjust && (Nop == 1) && !haveBackground)
+    if (adjust && Nop == 1 && !haveBackground)
        didAdjust = adjustNodes(g);
 
     if (didAdjust) {
@@ -582,17 +581,17 @@ int init_nop(Agraph_t * g, int adjust)
        node_t *n;
        State = GVSPLINES;
        for (n = agfstnode(g); n; n = agnxtnode(g, n)) {
-           ND_coord(n).x = POINTS_PER_INCH * (ND_pos(n)[0]);
-           ND_coord(n).y = POINTS_PER_INCH * (ND_pos(n)[1]);
+           ND_coord(n).x = POINTS_PER_INCH * ND_pos(n)[0];
+           ND_coord(n).y = POINTS_PER_INCH * ND_pos(n)[1];
        }
     }
     else {
        boolean didShift;
-       if (translate && !haveBackground && ((GD_bb(g).LL.x != 0)||(GD_bb(g).LL.y != 0)))
+       if (translate && !haveBackground && (GD_bb(g).LL.x != 0||GD_bb(g).LL.y != 0))
            neato_translate (g);
        didShift = neato_set_aspect(g);
        /* if we have some edge positions and we either shifted or adjusted, free edge positions */
-       if ((posEdges != NoEdges) && (didShift || didAdjust)) {
+       if (posEdges != NoEdges && (didShift || didAdjust)) {
            freeEdgeInfo (g);
            posEdges = NoEdges;
        }
@@ -706,7 +705,7 @@ dfsCycle (vtx_data* graph, int i,int mode, node_t* nodes[])
     /* if mode is IPSEP make it an in-edge
      * at both ends, so that an edge constraint won't be generated!
      */
-    double x = (mode==MODE_IPSEP?-1.0:1.0);
+    double x = mode==MODE_IPSEP?-1.0:1.0;
 
     np = nodes[i];
     ND_mark(np) = TRUE;
@@ -717,7 +716,7 @@ dfsCycle (vtx_data* graph, int i,int mode, node_t* nodes[])
        hp = nodes[j];
        if (ND_onstack(hp)) {  /* back edge: reverse it */
             graph[i].edists[e] = x;
-            for (f = 1; (f < graph[j].nedges) &&(graph[j].edges[f] != i); f++) ;
+            for (f = 1; f < graph[j].nedges && graph[j].edges[f] != i; f++) ;
             assert (f < graph[j].nedges);
             graph[j].edists[f] = -1.0;
         }
@@ -792,7 +791,7 @@ static vtx_data *makeGraphData(graph_t * g, int nv, int *nedges, int mode, int m
        haveWt = FALSE;
     } else {
        haveLen = agattr(g, AGEDGE, "len", 0) ;
-       haveWt = (E_weight != 0);
+       haveWt = E_weight != 0;
     }
     if (mode == MODE_HIER || mode == MODE_IPSEP)
        haveDir = TRUE;
@@ -848,7 +847,7 @@ static vtx_data *makeGraphData(graph_t * g, int nv, int *nedges, int mode, int m
                    graph[i].ewgts[idx] = MAX(ED_dist(ep), curlen);
                }
            } else {
-               node_t *vp = (((agtail(ep)) == np) ? aghead(ep) : agtail(ep));
+               node_t *vp = agtail(ep) == np ? aghead(ep) : agtail(ep);
                ne++;
                j++;
 
@@ -865,7 +864,7 @@ static vtx_data *makeGraphData(graph_t * g, int nv, int *nedges, int mode, int m
                     if(s&&!strncmp(s,"none",4)) {
                         *edists++ = 0;
                     } else {
-                        *edists++ = (np == aghead(ep) ? 1.0 : -1.0);
+                        *edists++ = np == aghead(ep) ? 1.0 : -1.0;
                     }
                 }
 #endif
@@ -927,7 +926,7 @@ static void initRegular(graph_t * G, int nG)
     node_t *np;
 
     a = 0.0;
-    da = (2 * M_PI) / nG;
+    da = 2 * M_PI / nG;
     for (np = agfstnode(G); np; np = agnxtnode(G, np)) {
        ND_pos(np)[0] = nG * Spring_coeff * cos(a);
        ND_pos(np)[1] = nG * Spring_coeff * sin(a);
@@ -959,7 +958,7 @@ setSeed (graph_t * G, int dflt, long* seedp)
     char *p = agget(G, "start");
     int init = dflt;
 
-    if (!p || (*p == '\0')) return dflt;
+    if (!p || *p == '\0') return dflt;
     if (isalpha(*(unsigned char *)p)) {
        if (!strncmp(p, SMART, SLEN(SMART))) {
            init = INIT_SELF;
@@ -1003,7 +1002,7 @@ setSeed (graph_t * G, int dflt, long* seedp)
 static int checkExp (graph_t * G)
 {
     int exp = late_int(G, agfindgraphattr(G, exp_name), 2, 0);
-    if ((exp == 0) || (exp > 2)) {
+    if (exp == 0 || exp > 2) {
        agerr (AGWARN, "%s attribute value must be 1 or 2 - ignoring\n", exp_name);
        exp = 2;
     }
@@ -1027,7 +1026,7 @@ int checkStart(graph_t * G, int nG, int dflt)
 
     seed = 1;
     init = setSeed (G, dflt, &seed);
-    if (N_pos && (init != INIT_RANDOM)) {
+    if (N_pos && init != INIT_RANDOM) {
        agerr(AGWARN, "node positions are ignored unless start=random\n");
     }
     if (init == INIT_REGULAR) initRegular(G, nG);
@@ -1134,7 +1133,7 @@ majorization(graph_t *mg, graph_t * g, int nv, int mode, int model, int dim, int
     expand_t margin;
 #endif
 #endif
-    int init = checkStart(g, nv, (mode == MODE_HIER ? INIT_SELF : INIT_RANDOM));
+    int init = checkStart(g, nv, mode == MODE_HIER ? INIT_SELF : INIT_RANDOM);
     int opts = checkExp (g);
 
     if (init == INIT_SELF)
@@ -1147,7 +1146,7 @@ majorization(graph_t *mg, graph_t * g, int nv, int mode, int model, int dim, int
     }
     if (Verbose) {
        fprintf(stderr, "model %d smart_init %d stresswt %d iterations %d tol %f\n",
-               model, (init == INIT_SELF), opts & opt_exp_flag, MaxIter, Epsilon);
+               model, init == INIT_SELF, opts & opt_exp_flag, MaxIter, Epsilon);
        fprintf(stderr, "convert graph: ");
        start_timer();
         fprintf(stderr, "majorization\n");
@@ -1352,7 +1351,7 @@ neatoLayout(Agraph_t * mg, Agraph_t * g, int layoutMode, int layoutModel,
        MaxIter = 100 * agnnodes(g);
 
     nG = scan_graph_mode(g, layoutMode);
-    if ((nG < 2) || (MaxIter < 0))
+    if (nG < 2 || MaxIter < 0)
        return;
     if (layoutMode == MODE_KK)
        kkNeato(g, nG, layoutModel);
@@ -1371,9 +1370,9 @@ static void addZ (Agraph_t* g)
     node_t* n;
     char    buf[BUFSIZ];
 
-    if ((Ndim >= 3) && N_z) {
+    if (Ndim >= 3 && N_z) {
        for (n = agfstnode(g); n; n = agnxtnode(g, n)) {
-           snprintf(buf, sizeof(buf), "%lf", POINTS_PER_INCH * (ND_pos(n)[2]));
+           snprintf(buf, sizeof(buf), "%lf", POINTS_PER_INCH * ND_pos(n)[2]);
            agxset(n, N_z, buf);
        }
     }
@@ -1440,7 +1439,7 @@ void neato_layout(Agraph_t * g)
            /* If the user has not indicated packing but we are
             * using the new neato, turn packing on.
             */
-           if ((Pack < 0) && layoutMode)
+           if (Pack < 0 && layoutMode)
                Pack = CL_OFFSET;
            pinfo.mode = l_node;
        } else if (Pack < 0)
index 382e05fe3f55bc32455001a8cfb4c340b0988d64..093831df7bd7c615b48cb7af886c5762f60e532b 100644 (file)
@@ -50,7 +50,7 @@ void voronoi(int triangulate, Site * (*nextsite) (void))
 #ifdef STANDALONE
            out_site(newsite);
 #endif
-           lbnd = ELleftbnd(&(newsite->coord));
+           lbnd = ELleftbnd(&newsite->coord);
            rbnd = ELright(lbnd);
            bot = rightreg(lbnd);
            e = gvbisect(bot, newsite);